├── .gitattributes ├── .github ├── WORKFLOW.md ├── actions │ ├── test-macos │ │ └── action.yml │ └── test-ubuntu │ │ └── action.yml ├── codecov.yml └── workflows │ ├── copyright.yml │ ├── docker_solver_build.yml │ ├── documentation.yml │ └── tests.yml ├── .gitignore ├── .licenserc.json ├── CMakeLists.txt ├── Code ├── CMake │ ├── FindINTELRUNTIME.cmake │ ├── LINEAR_SOLVERConfig.cmake │ ├── SimVascularDependentOptions.cmake │ ├── SimVascularExternals.cmake │ ├── SimVascularFunctionCheckCompilerFlags.cmake │ ├── SimVascularFunctions.cmake │ ├── SimVascularInstallLibs.cmake │ ├── SimVascularInstallSetup.cmake │ ├── SimVascularInternals.cmake │ ├── SimVascularMacros.cmake │ ├── SimVascularOptions.cmake │ ├── SimVascularSystemSetup.cmake │ ├── SimVascularThirdParty.cmake │ └── Superbuild.cmake ├── CMakeLists.txt ├── Source │ ├── CMakeLists.txt │ ├── Include │ │ ├── CMakeLists.txt │ │ ├── SimVascular.h │ │ ├── cvFlowsolverOptions.h.in │ │ ├── simvascular_options.h.in │ │ └── simvascular_version.h.in │ ├── liner_solver │ │ ├── CMakeLists.txt │ │ ├── README.md │ │ ├── add_bc_mul.cpp │ │ ├── add_bc_mul.h │ │ ├── bc.cpp │ │ ├── bcast.cpp │ │ ├── bcast.h │ │ ├── bicgs.cpp │ │ ├── bicgs.h │ │ ├── cgrad.cpp │ │ ├── cgrad.h │ │ ├── commu.cpp │ │ ├── commu.h │ │ ├── cput.cpp │ │ ├── dot.cpp │ │ ├── dot.h │ │ ├── fils_struct.cpp │ │ ├── fils_struct.hpp │ │ ├── fsils.hpp │ │ ├── fsils_api.hpp │ │ ├── fsils_std.h │ │ ├── ge.cpp │ │ ├── ge.h │ │ ├── gmres.cpp │ │ ├── gmres.h │ │ ├── in_commu.cpp │ │ ├── lhs.cpp │ │ ├── lhs.h │ │ ├── ls.cpp │ │ ├── norm.cpp │ │ ├── norm.h │ │ ├── ns_solver.cpp │ │ ├── ns_solver.h │ │ ├── omp_la.cpp │ │ ├── omp_la.h │ │ ├── pc_gmres.cpp │ │ ├── pc_gmres.h │ │ ├── precond.cpp │ │ ├── precond.h │ │ ├── solve.cpp │ │ ├── spar_mul.cpp │ │ └── spar_mul.h │ └── solver │ │ ├── Array.cpp │ │ ├── Array.h │ │ ├── Array3.cpp │ │ ├── Array3.h │ │ ├── ArtificialNeuralNetMaterial.cpp │ │ ├── ArtificialNeuralNetMaterial.h │ │ ├── BoundaryCondition.cpp │ │ ├── BoundaryCondition.h │ │ ├── CMakeLists.txt │ │ ├── CepMod.cpp │ │ ├── CepMod.h │ │ ├── CepModAp.cpp │ │ ├── CepModAp.h │ │ ├── CepModBo.cpp │ │ ├── CepModBo.h │ │ ├── CepModFn.cpp │ │ ├── CepModFn.h │ │ ├── CepModTtp.cpp │ │ ├── CepModTtp.h │ │ ├── ChnlMod.cpp │ │ ├── ChnlMod.h │ │ ├── CmMod.cpp │ │ ├── CmMod.h │ │ ├── ComMod.cpp │ │ ├── ComMod.h │ │ ├── DebugMsg.h │ │ ├── FsilsLinearAlgebra.cpp │ │ ├── FsilsLinearAlgebra.h │ │ ├── LinearAlgebra.cpp │ │ ├── LinearAlgebra.h │ │ ├── Parameters.cpp │ │ ├── Parameters.cpp.orig │ │ ├── Parameters.h │ │ ├── PetscLinearAlgebra.cpp │ │ ├── PetscLinearAlgebra.h │ │ ├── README-trilinos.md │ │ ├── README.md │ │ ├── RobinBoundaryCondition.cpp │ │ ├── RobinBoundaryCondition.h │ │ ├── SPLIT.c │ │ ├── Simulation.cpp │ │ ├── Simulation.h │ │ ├── SimulationLogger.h │ │ ├── Tensor4.cpp │ │ ├── Tensor4.h │ │ ├── Timer.h │ │ ├── TrilinosLinearAlgebra.cpp │ │ ├── TrilinosLinearAlgebra.h │ │ ├── Vector.cpp │ │ ├── Vector.h │ │ ├── VtkData.cpp │ │ ├── VtkData.h │ │ ├── all_fun.cpp │ │ ├── all_fun.h │ │ ├── baf_ini.cpp │ │ ├── baf_ini.h │ │ ├── bf.cpp │ │ ├── bf.h │ │ ├── cep.cpp │ │ ├── cep.h │ │ ├── cep_ion.cpp │ │ ├── cep_ion.h │ │ ├── cmm.cpp │ │ ├── cmm.h │ │ ├── consts.cpp │ │ ├── consts.h │ │ ├── contact.cpp │ │ ├── contact.h │ │ ├── distribute.cpp │ │ ├── distribute.h │ │ ├── eq_assem.cpp │ │ ├── eq_assem.h │ │ ├── fft.cpp │ │ ├── fft.h │ │ ├── fluid.cpp │ │ ├── fluid.h │ │ ├── fs.cpp │ │ ├── fs.h │ │ ├── fsi.cpp │ │ ├── fsi.h │ │ ├── gmres.cpp │ │ ├── heatf.cpp │ │ ├── heatf.h │ │ ├── heats.cpp │ │ ├── heats.h │ │ ├── initialize.cpp │ │ ├── initialize.h │ │ ├── interface.cpp │ │ ├── l_elas.cpp │ │ ├── l_elas.h │ │ ├── lapack_defs.h │ │ ├── lhsa.cpp │ │ ├── lhsa.h │ │ ├── load_msh.cpp │ │ ├── load_msh.h │ │ ├── ls.cpp │ │ ├── ls.h │ │ ├── main.cpp │ │ ├── mat_fun.cpp │ │ ├── mat_fun.h │ │ ├── mat_models.cpp │ │ ├── mat_models.h │ │ ├── mesh.cpp │ │ ├── mesh.h │ │ ├── mueluOptions.xml │ │ ├── nn.cpp │ │ ├── nn.h │ │ ├── nn_elem_gip.h │ │ ├── nn_elem_gnn.h │ │ ├── nn_elem_gnnxx.h │ │ ├── nn_elem_nn_bnds.h │ │ ├── nn_elem_props.h │ │ ├── output.cpp │ │ ├── output.h │ │ ├── petsc_impl.cpp │ │ ├── petsc_impl.h │ │ ├── pic.cpp │ │ ├── pic.h │ │ ├── post.cpp │ │ ├── post.h │ │ ├── read_files.cpp │ │ ├── read_files.h │ │ ├── read_msh.cpp │ │ ├── read_msh.h │ │ ├── remesh.cpp │ │ ├── remesh.h │ │ ├── remeshTet.cpp │ │ ├── remeshTet.h │ │ ├── ris.cpp │ │ ├── ris.h │ │ ├── set_bc.cpp │ │ ├── set_bc.h │ │ ├── set_equation_dof.h │ │ ├── set_equation_props.h │ │ ├── set_material_props.h │ │ ├── set_output_props.h │ │ ├── set_viscosity_props.h │ │ ├── shells.cpp │ │ ├── shells.h │ │ ├── stokes.cpp │ │ ├── stokes.h │ │ ├── svZeroD_interface │ │ ├── LPNSolverInterface.cpp │ │ └── LPNSolverInterface.h │ │ ├── svZeroD_subroutines.cpp │ │ ├── svZeroD_subroutines.h │ │ ├── sv_struct.cpp │ │ ├── sv_struct.h │ │ ├── trilinos_impl.cpp │ │ ├── trilinos_impl.h │ │ ├── txt.cpp │ │ ├── txt.h │ │ ├── uris.cpp │ │ ├── uris.h │ │ ├── ustruct.cpp │ │ ├── ustruct.h │ │ ├── utils.cpp │ │ ├── utils.h │ │ ├── vtk_xml.cpp │ │ ├── vtk_xml.h │ │ ├── vtk_xml_parser.cpp │ │ └── vtk_xml_parser.h └── ThirdParty │ ├── README.md │ ├── eigen │ ├── include │ │ └── eigen3 │ │ │ ├── Eigen │ │ │ ├── Cholesky │ │ │ ├── CholmodSupport │ │ │ ├── Core │ │ │ ├── Dense │ │ │ ├── Eigen │ │ │ ├── Eigenvalues │ │ │ ├── Geometry │ │ │ ├── Householder │ │ │ ├── IterativeLinearSolvers │ │ │ ├── Jacobi │ │ │ ├── KLUSupport │ │ │ ├── LU │ │ │ ├── MetisSupport │ │ │ ├── OrderingMethods │ │ │ ├── PaStiXSupport │ │ │ ├── PardisoSupport │ │ │ ├── QR │ │ │ ├── QtAlignedMalloc │ │ │ ├── SPQRSupport │ │ │ ├── SVD │ │ │ ├── Sparse │ │ │ ├── SparseCholesky │ │ │ ├── SparseCore │ │ │ ├── SparseLU │ │ │ ├── SparseQR │ │ │ ├── StdDeque │ │ │ ├── StdList │ │ │ ├── StdVector │ │ │ ├── SuperLUSupport │ │ │ ├── UmfPackSupport │ │ │ └── src │ │ │ │ ├── Cholesky │ │ │ │ ├── LDLT.h │ │ │ │ ├── LLT.h │ │ │ │ └── LLT_LAPACKE.h │ │ │ │ ├── CholmodSupport │ │ │ │ └── CholmodSupport.h │ │ │ │ ├── Core │ │ │ │ ├── ArithmeticSequence.h │ │ │ │ ├── Array.h │ │ │ │ ├── ArrayBase.h │ │ │ │ ├── ArrayWrapper.h │ │ │ │ ├── Assign.h │ │ │ │ ├── AssignEvaluator.h │ │ │ │ ├── Assign_MKL.h │ │ │ │ ├── BandMatrix.h │ │ │ │ ├── Block.h │ │ │ │ ├── BooleanRedux.h │ │ │ │ ├── CommaInitializer.h │ │ │ │ ├── ConditionEstimator.h │ │ │ │ ├── CoreEvaluators.h │ │ │ │ ├── CoreIterators.h │ │ │ │ ├── CwiseBinaryOp.h │ │ │ │ ├── CwiseNullaryOp.h │ │ │ │ ├── CwiseTernaryOp.h │ │ │ │ ├── CwiseUnaryOp.h │ │ │ │ ├── CwiseUnaryView.h │ │ │ │ ├── DenseBase.h │ │ │ │ ├── DenseCoeffsBase.h │ │ │ │ ├── DenseStorage.h │ │ │ │ ├── Diagonal.h │ │ │ │ ├── DiagonalMatrix.h │ │ │ │ ├── DiagonalProduct.h │ │ │ │ ├── Dot.h │ │ │ │ ├── EigenBase.h │ │ │ │ ├── ForceAlignedAccess.h │ │ │ │ ├── Fuzzy.h │ │ │ │ ├── GeneralProduct.h │ │ │ │ ├── GenericPacketMath.h │ │ │ │ ├── GlobalFunctions.h │ │ │ │ ├── IO.h │ │ │ │ ├── IndexedView.h │ │ │ │ ├── Inverse.h │ │ │ │ ├── Map.h │ │ │ │ ├── MapBase.h │ │ │ │ ├── MathFunctions.h │ │ │ │ ├── MathFunctionsImpl.h │ │ │ │ ├── Matrix.h │ │ │ │ ├── MatrixBase.h │ │ │ │ ├── NestByValue.h │ │ │ │ ├── NoAlias.h │ │ │ │ ├── NumTraits.h │ │ │ │ ├── PartialReduxEvaluator.h │ │ │ │ ├── PermutationMatrix.h │ │ │ │ ├── PlainObjectBase.h │ │ │ │ ├── Product.h │ │ │ │ ├── ProductEvaluators.h │ │ │ │ ├── Random.h │ │ │ │ ├── Redux.h │ │ │ │ ├── Ref.h │ │ │ │ ├── Replicate.h │ │ │ │ ├── Reshaped.h │ │ │ │ ├── ReturnByValue.h │ │ │ │ ├── Reverse.h │ │ │ │ ├── Select.h │ │ │ │ ├── SelfAdjointView.h │ │ │ │ ├── SelfCwiseBinaryOp.h │ │ │ │ ├── Solve.h │ │ │ │ ├── SolveTriangular.h │ │ │ │ ├── SolverBase.h │ │ │ │ ├── StableNorm.h │ │ │ │ ├── StlIterators.h │ │ │ │ ├── Stride.h │ │ │ │ ├── Swap.h │ │ │ │ ├── Transpose.h │ │ │ │ ├── Transpositions.h │ │ │ │ ├── TriangularMatrix.h │ │ │ │ ├── VectorBlock.h │ │ │ │ ├── VectorwiseOp.h │ │ │ │ ├── Visitor.h │ │ │ │ ├── arch │ │ │ │ │ ├── AVX │ │ │ │ │ │ ├── Complex.h │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ ├── PacketMath.h │ │ │ │ │ │ └── TypeCasting.h │ │ │ │ │ ├── AVX512 │ │ │ │ │ │ ├── Complex.h │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ ├── PacketMath.h │ │ │ │ │ │ └── TypeCasting.h │ │ │ │ │ ├── AltiVec │ │ │ │ │ │ ├── Complex.h │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ ├── MatrixProduct.h │ │ │ │ │ │ ├── MatrixProductCommon.h │ │ │ │ │ │ ├── MatrixProductMMA.h │ │ │ │ │ │ └── PacketMath.h │ │ │ │ │ ├── CUDA │ │ │ │ │ │ └── Complex.h │ │ │ │ │ ├── Default │ │ │ │ │ │ ├── BFloat16.h │ │ │ │ │ │ ├── ConjHelper.h │ │ │ │ │ │ ├── GenericPacketMathFunctions.h │ │ │ │ │ │ ├── GenericPacketMathFunctionsFwd.h │ │ │ │ │ │ ├── Half.h │ │ │ │ │ │ ├── Settings.h │ │ │ │ │ │ └── TypeCasting.h │ │ │ │ │ ├── GPU │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ ├── PacketMath.h │ │ │ │ │ │ └── TypeCasting.h │ │ │ │ │ ├── HIP │ │ │ │ │ │ └── hcc │ │ │ │ │ │ │ └── math_constants.h │ │ │ │ │ ├── MSA │ │ │ │ │ │ ├── Complex.h │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ └── PacketMath.h │ │ │ │ │ ├── NEON │ │ │ │ │ │ ├── Complex.h │ │ │ │ │ │ ├── GeneralBlockPanelKernel.h │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ ├── PacketMath.h │ │ │ │ │ │ └── TypeCasting.h │ │ │ │ │ ├── SSE │ │ │ │ │ │ ├── Complex.h │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ ├── PacketMath.h │ │ │ │ │ │ └── TypeCasting.h │ │ │ │ │ ├── SVE │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ ├── PacketMath.h │ │ │ │ │ │ └── TypeCasting.h │ │ │ │ │ ├── SYCL │ │ │ │ │ │ ├── InteropHeaders.h │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ ├── PacketMath.h │ │ │ │ │ │ ├── SyclMemoryModel.h │ │ │ │ │ │ └── TypeCasting.h │ │ │ │ │ └── ZVector │ │ │ │ │ │ ├── Complex.h │ │ │ │ │ │ ├── MathFunctions.h │ │ │ │ │ │ └── PacketMath.h │ │ │ │ ├── functors │ │ │ │ │ ├── AssignmentFunctors.h │ │ │ │ │ ├── BinaryFunctors.h │ │ │ │ │ ├── NullaryFunctors.h │ │ │ │ │ ├── StlFunctors.h │ │ │ │ │ ├── TernaryFunctors.h │ │ │ │ │ └── UnaryFunctors.h │ │ │ │ ├── products │ │ │ │ │ ├── GeneralBlockPanelKernel.h │ │ │ │ │ ├── GeneralMatrixMatrix.h │ │ │ │ │ ├── GeneralMatrixMatrixTriangular.h │ │ │ │ │ ├── GeneralMatrixMatrixTriangular_BLAS.h │ │ │ │ │ ├── GeneralMatrixMatrix_BLAS.h │ │ │ │ │ ├── GeneralMatrixVector.h │ │ │ │ │ ├── GeneralMatrixVector_BLAS.h │ │ │ │ │ ├── Parallelizer.h │ │ │ │ │ ├── SelfadjointMatrixMatrix.h │ │ │ │ │ ├── SelfadjointMatrixMatrix_BLAS.h │ │ │ │ │ ├── SelfadjointMatrixVector.h │ │ │ │ │ ├── SelfadjointMatrixVector_BLAS.h │ │ │ │ │ ├── SelfadjointProduct.h │ │ │ │ │ ├── SelfadjointRank2Update.h │ │ │ │ │ ├── TriangularMatrixMatrix.h │ │ │ │ │ ├── TriangularMatrixMatrix_BLAS.h │ │ │ │ │ ├── TriangularMatrixVector.h │ │ │ │ │ ├── TriangularMatrixVector_BLAS.h │ │ │ │ │ ├── TriangularSolverMatrix.h │ │ │ │ │ ├── TriangularSolverMatrix_BLAS.h │ │ │ │ │ └── TriangularSolverVector.h │ │ │ │ └── util │ │ │ │ │ ├── BlasUtil.h │ │ │ │ │ ├── ConfigureVectorization.h │ │ │ │ │ ├── Constants.h │ │ │ │ │ ├── DisableStupidWarnings.h │ │ │ │ │ ├── ForwardDeclarations.h │ │ │ │ │ ├── IndexedViewHelper.h │ │ │ │ │ ├── IntegralConstant.h │ │ │ │ │ ├── MKL_support.h │ │ │ │ │ ├── Macros.h │ │ │ │ │ ├── Memory.h │ │ │ │ │ ├── Meta.h │ │ │ │ │ ├── NonMPL2.h │ │ │ │ │ ├── ReenableStupidWarnings.h │ │ │ │ │ ├── ReshapedHelper.h │ │ │ │ │ ├── StaticAssert.h │ │ │ │ │ ├── SymbolicIndex.h │ │ │ │ │ └── XprHelper.h │ │ │ │ ├── Eigenvalues │ │ │ │ ├── ComplexEigenSolver.h │ │ │ │ ├── ComplexSchur.h │ │ │ │ ├── ComplexSchur_LAPACKE.h │ │ │ │ ├── EigenSolver.h │ │ │ │ ├── GeneralizedEigenSolver.h │ │ │ │ ├── GeneralizedSelfAdjointEigenSolver.h │ │ │ │ ├── HessenbergDecomposition.h │ │ │ │ ├── MatrixBaseEigenvalues.h │ │ │ │ ├── RealQZ.h │ │ │ │ ├── RealSchur.h │ │ │ │ ├── RealSchur_LAPACKE.h │ │ │ │ ├── SelfAdjointEigenSolver.h │ │ │ │ ├── SelfAdjointEigenSolver_LAPACKE.h │ │ │ │ └── Tridiagonalization.h │ │ │ │ ├── Geometry │ │ │ │ ├── AlignedBox.h │ │ │ │ ├── AngleAxis.h │ │ │ │ ├── EulerAngles.h │ │ │ │ ├── Homogeneous.h │ │ │ │ ├── Hyperplane.h │ │ │ │ ├── OrthoMethods.h │ │ │ │ ├── ParametrizedLine.h │ │ │ │ ├── Quaternion.h │ │ │ │ ├── Rotation2D.h │ │ │ │ ├── RotationBase.h │ │ │ │ ├── Scaling.h │ │ │ │ ├── Transform.h │ │ │ │ ├── Translation.h │ │ │ │ ├── Umeyama.h │ │ │ │ └── arch │ │ │ │ │ └── Geometry_SIMD.h │ │ │ │ ├── Householder │ │ │ │ ├── BlockHouseholder.h │ │ │ │ ├── Householder.h │ │ │ │ └── HouseholderSequence.h │ │ │ │ ├── IterativeLinearSolvers │ │ │ │ ├── BasicPreconditioners.h │ │ │ │ ├── BiCGSTAB.h │ │ │ │ ├── ConjugateGradient.h │ │ │ │ ├── IncompleteCholesky.h │ │ │ │ ├── IncompleteLUT.h │ │ │ │ ├── IterativeSolverBase.h │ │ │ │ ├── LeastSquareConjugateGradient.h │ │ │ │ └── SolveWithGuess.h │ │ │ │ ├── Jacobi │ │ │ │ └── Jacobi.h │ │ │ │ ├── KLUSupport │ │ │ │ └── KLUSupport.h │ │ │ │ ├── LU │ │ │ │ ├── Determinant.h │ │ │ │ ├── FullPivLU.h │ │ │ │ ├── InverseImpl.h │ │ │ │ ├── PartialPivLU.h │ │ │ │ ├── PartialPivLU_LAPACKE.h │ │ │ │ └── arch │ │ │ │ │ └── InverseSize4.h │ │ │ │ ├── MetisSupport │ │ │ │ └── MetisSupport.h │ │ │ │ ├── OrderingMethods │ │ │ │ ├── Amd.h │ │ │ │ ├── Eigen_Colamd.h │ │ │ │ └── Ordering.h │ │ │ │ ├── PaStiXSupport │ │ │ │ └── PaStiXSupport.h │ │ │ │ ├── PardisoSupport │ │ │ │ └── PardisoSupport.h │ │ │ │ ├── QR │ │ │ │ ├── ColPivHouseholderQR.h │ │ │ │ ├── ColPivHouseholderQR_LAPACKE.h │ │ │ │ ├── CompleteOrthogonalDecomposition.h │ │ │ │ ├── FullPivHouseholderQR.h │ │ │ │ ├── HouseholderQR.h │ │ │ │ └── HouseholderQR_LAPACKE.h │ │ │ │ ├── SPQRSupport │ │ │ │ └── SuiteSparseQRSupport.h │ │ │ │ ├── SVD │ │ │ │ ├── BDCSVD.h │ │ │ │ ├── JacobiSVD.h │ │ │ │ ├── JacobiSVD_LAPACKE.h │ │ │ │ ├── SVDBase.h │ │ │ │ └── UpperBidiagonalization.h │ │ │ │ ├── SparseCholesky │ │ │ │ ├── SimplicialCholesky.h │ │ │ │ └── SimplicialCholesky_impl.h │ │ │ │ ├── SparseCore │ │ │ │ ├── AmbiVector.h │ │ │ │ ├── CompressedStorage.h │ │ │ │ ├── ConservativeSparseSparseProduct.h │ │ │ │ ├── MappedSparseMatrix.h │ │ │ │ ├── SparseAssign.h │ │ │ │ ├── SparseBlock.h │ │ │ │ ├── SparseColEtree.h │ │ │ │ ├── SparseCompressedBase.h │ │ │ │ ├── SparseCwiseBinaryOp.h │ │ │ │ ├── SparseCwiseUnaryOp.h │ │ │ │ ├── SparseDenseProduct.h │ │ │ │ ├── SparseDiagonalProduct.h │ │ │ │ ├── SparseDot.h │ │ │ │ ├── SparseFuzzy.h │ │ │ │ ├── SparseMap.h │ │ │ │ ├── SparseMatrix.h │ │ │ │ ├── SparseMatrixBase.h │ │ │ │ ├── SparsePermutation.h │ │ │ │ ├── SparseProduct.h │ │ │ │ ├── SparseRedux.h │ │ │ │ ├── SparseRef.h │ │ │ │ ├── SparseSelfAdjointView.h │ │ │ │ ├── SparseSolverBase.h │ │ │ │ ├── SparseSparseProductWithPruning.h │ │ │ │ ├── SparseTranspose.h │ │ │ │ ├── SparseTriangularView.h │ │ │ │ ├── SparseUtil.h │ │ │ │ ├── SparseVector.h │ │ │ │ ├── SparseView.h │ │ │ │ └── TriangularSolver.h │ │ │ │ ├── SparseLU │ │ │ │ ├── SparseLU.h │ │ │ │ ├── SparseLUImpl.h │ │ │ │ ├── SparseLU_Memory.h │ │ │ │ ├── SparseLU_Structs.h │ │ │ │ ├── SparseLU_SupernodalMatrix.h │ │ │ │ ├── SparseLU_Utils.h │ │ │ │ ├── SparseLU_column_bmod.h │ │ │ │ ├── SparseLU_column_dfs.h │ │ │ │ ├── SparseLU_copy_to_ucol.h │ │ │ │ ├── SparseLU_gemm_kernel.h │ │ │ │ ├── SparseLU_heap_relax_snode.h │ │ │ │ ├── SparseLU_kernel_bmod.h │ │ │ │ ├── SparseLU_panel_bmod.h │ │ │ │ ├── SparseLU_panel_dfs.h │ │ │ │ ├── SparseLU_pivotL.h │ │ │ │ ├── SparseLU_pruneL.h │ │ │ │ └── SparseLU_relax_snode.h │ │ │ │ ├── SparseQR │ │ │ │ └── SparseQR.h │ │ │ │ ├── StlSupport │ │ │ │ ├── StdDeque.h │ │ │ │ ├── StdList.h │ │ │ │ ├── StdVector.h │ │ │ │ └── details.h │ │ │ │ ├── SuperLUSupport │ │ │ │ └── SuperLUSupport.h │ │ │ │ ├── UmfPackSupport │ │ │ │ └── UmfPackSupport.h │ │ │ │ ├── misc │ │ │ │ ├── Image.h │ │ │ │ ├── Kernel.h │ │ │ │ ├── RealSvd2x2.h │ │ │ │ ├── blas.h │ │ │ │ ├── lapack.h │ │ │ │ ├── lapacke.h │ │ │ │ └── lapacke_mangling.h │ │ │ │ └── plugins │ │ │ │ ├── ArrayCwiseBinaryOps.h │ │ │ │ ├── ArrayCwiseUnaryOps.h │ │ │ │ ├── BlockMethods.h │ │ │ │ ├── CommonCwiseBinaryOps.h │ │ │ │ ├── CommonCwiseUnaryOps.h │ │ │ │ ├── IndexedViewMethods.h │ │ │ │ ├── MatrixCwiseBinaryOps.h │ │ │ │ ├── MatrixCwiseUnaryOps.h │ │ │ │ └── ReshapedMethods.h │ │ │ ├── signature_of_eigen3_matrix_library │ │ │ └── unsupported │ │ │ └── Eigen │ │ │ ├── AdolcForward │ │ │ ├── AlignedVector3 │ │ │ ├── ArpackSupport │ │ │ ├── AutoDiff │ │ │ ├── BVH │ │ │ ├── CXX11 │ │ │ ├── Tensor │ │ │ ├── TensorSymmetry │ │ │ ├── ThreadPool │ │ │ └── src │ │ │ │ ├── Tensor │ │ │ │ ├── Tensor.h │ │ │ │ ├── TensorArgMax.h │ │ │ │ ├── TensorAssign.h │ │ │ │ ├── TensorBase.h │ │ │ │ ├── TensorBlock.h │ │ │ │ ├── TensorBroadcasting.h │ │ │ │ ├── TensorChipping.h │ │ │ │ ├── TensorConcatenation.h │ │ │ │ ├── TensorContraction.h │ │ │ │ ├── TensorContractionBlocking.h │ │ │ │ ├── TensorContractionCuda.h │ │ │ │ ├── TensorContractionGpu.h │ │ │ │ ├── TensorContractionMapper.h │ │ │ │ ├── TensorContractionSycl.h │ │ │ │ ├── TensorContractionThreadPool.h │ │ │ │ ├── TensorConversion.h │ │ │ │ ├── TensorConvolution.h │ │ │ │ ├── TensorConvolutionSycl.h │ │ │ │ ├── TensorCostModel.h │ │ │ │ ├── TensorCustomOp.h │ │ │ │ ├── TensorDevice.h │ │ │ │ ├── TensorDeviceCuda.h │ │ │ │ ├── TensorDeviceDefault.h │ │ │ │ ├── TensorDeviceGpu.h │ │ │ │ ├── TensorDeviceSycl.h │ │ │ │ ├── TensorDeviceThreadPool.h │ │ │ │ ├── TensorDimensionList.h │ │ │ │ ├── TensorDimensions.h │ │ │ │ ├── TensorEvalTo.h │ │ │ │ ├── TensorEvaluator.h │ │ │ │ ├── TensorExecutor.h │ │ │ │ ├── TensorExpr.h │ │ │ │ ├── TensorFFT.h │ │ │ │ ├── TensorFixedSize.h │ │ │ │ ├── TensorForcedEval.h │ │ │ │ ├── TensorForwardDeclarations.h │ │ │ │ ├── TensorFunctors.h │ │ │ │ ├── TensorGenerator.h │ │ │ │ ├── TensorGlobalFunctions.h │ │ │ │ ├── TensorGpuHipCudaDefines.h │ │ │ │ ├── TensorGpuHipCudaUndefines.h │ │ │ │ ├── TensorIO.h │ │ │ │ ├── TensorImagePatch.h │ │ │ │ ├── TensorIndexList.h │ │ │ │ ├── TensorInflation.h │ │ │ │ ├── TensorInitializer.h │ │ │ │ ├── TensorIntDiv.h │ │ │ │ ├── TensorLayoutSwap.h │ │ │ │ ├── TensorMacros.h │ │ │ │ ├── TensorMap.h │ │ │ │ ├── TensorMeta.h │ │ │ │ ├── TensorMorphing.h │ │ │ │ ├── TensorPadding.h │ │ │ │ ├── TensorPatch.h │ │ │ │ ├── TensorRandom.h │ │ │ │ ├── TensorReduction.h │ │ │ │ ├── TensorReductionCuda.h │ │ │ │ ├── TensorReductionGpu.h │ │ │ │ ├── TensorReductionSycl.h │ │ │ │ ├── TensorRef.h │ │ │ │ ├── TensorReverse.h │ │ │ │ ├── TensorScan.h │ │ │ │ ├── TensorScanSycl.h │ │ │ │ ├── TensorShuffling.h │ │ │ │ ├── TensorStorage.h │ │ │ │ ├── TensorStriding.h │ │ │ │ ├── TensorTrace.h │ │ │ │ ├── TensorTraits.h │ │ │ │ ├── TensorUInt128.h │ │ │ │ └── TensorVolumePatch.h │ │ │ │ ├── TensorSymmetry │ │ │ │ ├── DynamicSymmetry.h │ │ │ │ ├── StaticSymmetry.h │ │ │ │ ├── Symmetry.h │ │ │ │ └── util │ │ │ │ │ └── TemplateGroupTheory.h │ │ │ │ ├── ThreadPool │ │ │ │ ├── Barrier.h │ │ │ │ ├── EventCount.h │ │ │ │ ├── NonBlockingThreadPool.h │ │ │ │ ├── RunQueue.h │ │ │ │ ├── ThreadCancel.h │ │ │ │ ├── ThreadEnvironment.h │ │ │ │ ├── ThreadLocal.h │ │ │ │ ├── ThreadPoolInterface.h │ │ │ │ └── ThreadYield.h │ │ │ │ └── util │ │ │ │ ├── CXX11Meta.h │ │ │ │ ├── CXX11Workarounds.h │ │ │ │ ├── EmulateArray.h │ │ │ │ └── MaxSizeVector.h │ │ │ ├── EulerAngles │ │ │ ├── FFT │ │ │ ├── IterativeSolvers │ │ │ ├── KroneckerProduct │ │ │ ├── LevenbergMarquardt │ │ │ ├── MPRealSupport │ │ │ ├── MatrixFunctions │ │ │ ├── MoreVectorization │ │ │ ├── NonLinearOptimization │ │ │ ├── NumericalDiff │ │ │ ├── OpenGLSupport │ │ │ ├── Polynomials │ │ │ ├── Skyline │ │ │ ├── SparseExtra │ │ │ ├── SpecialFunctions │ │ │ ├── Splines │ │ │ └── src │ │ │ ├── AutoDiff │ │ │ ├── AutoDiffJacobian.h │ │ │ ├── AutoDiffScalar.h │ │ │ └── AutoDiffVector.h │ │ │ ├── BVH │ │ │ ├── BVAlgorithms.h │ │ │ └── KdBVH.h │ │ │ ├── Eigenvalues │ │ │ └── ArpackSelfAdjointEigenSolver.h │ │ │ ├── EulerAngles │ │ │ ├── EulerAngles.h │ │ │ └── EulerSystem.h │ │ │ ├── FFT │ │ │ ├── ei_fftw_impl.h │ │ │ └── ei_kissfft_impl.h │ │ │ ├── IterativeSolvers │ │ │ ├── ConstrainedConjGrad.h │ │ │ ├── DGMRES.h │ │ │ ├── GMRES.h │ │ │ ├── IDRS.h │ │ │ ├── IncompleteLU.h │ │ │ ├── IterationController.h │ │ │ ├── MINRES.h │ │ │ └── Scaling.h │ │ │ ├── KroneckerProduct │ │ │ └── KroneckerTensorProduct.h │ │ │ ├── LevenbergMarquardt │ │ │ ├── LMcovar.h │ │ │ ├── LMonestep.h │ │ │ ├── LMpar.h │ │ │ ├── LMqrsolv.h │ │ │ └── LevenbergMarquardt.h │ │ │ ├── MatrixFunctions │ │ │ ├── MatrixExponential.h │ │ │ ├── MatrixFunction.h │ │ │ ├── MatrixLogarithm.h │ │ │ ├── MatrixPower.h │ │ │ ├── MatrixSquareRoot.h │ │ │ └── StemFunction.h │ │ │ ├── MoreVectorization │ │ │ └── MathFunctions.h │ │ │ ├── NonLinearOptimization │ │ │ ├── HybridNonLinearSolver.h │ │ │ ├── LevenbergMarquardt.h │ │ │ ├── chkder.h │ │ │ ├── covar.h │ │ │ ├── dogleg.h │ │ │ ├── fdjac1.h │ │ │ ├── lmpar.h │ │ │ ├── qrsolv.h │ │ │ ├── r1mpyq.h │ │ │ ├── r1updt.h │ │ │ └── rwupdt.h │ │ │ ├── NumericalDiff │ │ │ └── NumericalDiff.h │ │ │ ├── Polynomials │ │ │ ├── Companion.h │ │ │ ├── PolynomialSolver.h │ │ │ └── PolynomialUtils.h │ │ │ ├── Skyline │ │ │ ├── SkylineInplaceLU.h │ │ │ ├── SkylineMatrix.h │ │ │ ├── SkylineMatrixBase.h │ │ │ ├── SkylineProduct.h │ │ │ ├── SkylineStorage.h │ │ │ └── SkylineUtil.h │ │ │ ├── SparseExtra │ │ │ ├── BlockOfDynamicSparseMatrix.h │ │ │ ├── BlockSparseMatrix.h │ │ │ ├── DynamicSparseMatrix.h │ │ │ ├── MarketIO.h │ │ │ ├── MatrixMarketIterator.h │ │ │ └── RandomSetter.h │ │ │ ├── SpecialFunctions │ │ │ ├── BesselFunctionsArrayAPI.h │ │ │ ├── BesselFunctionsBFloat16.h │ │ │ ├── BesselFunctionsFunctors.h │ │ │ ├── BesselFunctionsHalf.h │ │ │ ├── BesselFunctionsImpl.h │ │ │ ├── BesselFunctionsPacketMath.h │ │ │ ├── HipVectorCompatibility.h │ │ │ ├── SpecialFunctionsArrayAPI.h │ │ │ ├── SpecialFunctionsBFloat16.h │ │ │ ├── SpecialFunctionsFunctors.h │ │ │ ├── SpecialFunctionsHalf.h │ │ │ ├── SpecialFunctionsImpl.h │ │ │ ├── SpecialFunctionsPacketMath.h │ │ │ └── arch │ │ │ │ ├── AVX │ │ │ │ ├── BesselFunctions.h │ │ │ │ └── SpecialFunctions.h │ │ │ │ ├── AVX512 │ │ │ │ ├── BesselFunctions.h │ │ │ │ └── SpecialFunctions.h │ │ │ │ ├── GPU │ │ │ │ └── SpecialFunctions.h │ │ │ │ └── NEON │ │ │ │ ├── BesselFunctions.h │ │ │ │ └── SpecialFunctions.h │ │ │ └── Splines │ │ │ ├── Spline.h │ │ │ ├── SplineFitting.h │ │ │ └── SplineFwd.h │ └── share │ │ ├── eigen3 │ │ └── cmake │ │ │ ├── Eigen3Config.cmake │ │ │ ├── Eigen3ConfigVersion.cmake │ │ │ ├── Eigen3Targets.cmake │ │ │ └── UseEigen3.cmake │ │ └── pkgconfig │ │ └── eigen3.pc │ ├── gklib_internal │ ├── CMakeLists.txt │ ├── README.md │ ├── simvascular_gklib_internal.h.in │ └── simvascular_gklib_internal │ │ ├── CMakeLists.txt │ │ ├── GKlib.h │ │ ├── b64.c │ │ ├── blas.c │ │ ├── cache.c │ │ ├── csr.c │ │ ├── error.c │ │ ├── evaluate.c │ │ ├── fkvkselect.c │ │ ├── fs.c │ │ ├── getopt.c │ │ ├── gk_arch.h │ │ ├── gk_defs.h │ │ ├── gk_externs.h │ │ ├── gk_getopt.h │ │ ├── gk_macros.h │ │ ├── gk_mkblas.h │ │ ├── gk_mkmemory.h │ │ ├── gk_mkpqueue.h │ │ ├── gk_mkpqueue2.h │ │ ├── gk_mkrandom.h │ │ ├── gk_mksort.h │ │ ├── gk_mkutils.h │ │ ├── gk_ms_inttypes.h │ │ ├── gk_ms_stat.h │ │ ├── gk_ms_stdint.h │ │ ├── gk_proto.h │ │ ├── gk_struct.h │ │ ├── gk_types.h │ │ ├── gk_util.c │ │ ├── gkregex.c │ │ ├── gkregex.h │ │ ├── graph.c │ │ ├── htable.c │ │ ├── io.c │ │ ├── itemsets.c │ │ ├── mcore.c │ │ ├── memory.c │ │ ├── pqueue.c │ │ ├── random.c │ │ ├── rw.c │ │ ├── seq.c │ │ ├── sort.c │ │ ├── string.c │ │ ├── timers.c │ │ ├── tokenizer.c │ │ └── win32 │ │ ├── adapt.c │ │ └── adapt.h │ ├── metis_internal │ ├── CMakeLists.txt │ ├── README.md │ ├── simvascular_metis_internal.h.in │ └── simvascular_metis_internal │ │ ├── CHANGES │ │ ├── CMakeLists.txt │ │ ├── INSTALL │ │ ├── LICENSE.txt │ │ ├── METISLib │ │ ├── .gitignore │ │ ├── CMakeLists.txt │ │ ├── Makefile │ │ ├── auxapi.c │ │ ├── balance.c │ │ ├── bucketsort.c │ │ ├── checkgraph.c │ │ ├── coarsen.c │ │ ├── compress.c │ │ ├── contig.c │ │ ├── debug.c │ │ ├── defs.h │ │ ├── fm.c │ │ ├── fortran.c │ │ ├── frename.c │ │ ├── gklib.c │ │ ├── gklib_defs.h │ │ ├── gklib_rename.h │ │ ├── graph.c │ │ ├── initpart.c │ │ ├── kmetis.c │ │ ├── kwayfm.c │ │ ├── kwayrefine.c │ │ ├── macros.h │ │ ├── mcutil.c │ │ ├── mesh.c │ │ ├── meshpart.c │ │ ├── metis.h │ │ ├── metislib.h │ │ ├── minconn.c │ │ ├── mincover.c │ │ ├── mmd.c │ │ ├── ometis.c │ │ ├── options.c │ │ ├── parmetis.c │ │ ├── pmetis.c │ │ ├── proto.h │ │ ├── refine.c │ │ ├── rename.h │ │ ├── separator.c │ │ ├── sfm.c │ │ ├── srefine.c │ │ ├── stat.c │ │ ├── stdheaders.h │ │ ├── struct.h │ │ ├── timing.c │ │ ├── util.c │ │ └── wspace.c │ │ ├── Makefile │ │ ├── Makefile.in │ │ ├── README │ │ └── VERSION │ ├── msmpi │ ├── Include │ │ ├── mpi.f90 │ │ ├── mpi.h │ │ ├── mpi.h.org │ │ ├── mpif.h │ │ ├── mpif.h.org │ │ ├── mpio.h │ │ ├── mspms.h │ │ ├── pmidbg.h │ │ ├── x64 │ │ │ └── mpifptr.h │ │ └── x86 │ │ │ └── mpifptr.h │ ├── Installers │ │ └── msmpisdk.msi │ └── License │ │ └── license_sdk.rtf │ ├── parmetis_internal │ ├── CMakeLists.txt │ ├── README.md │ ├── simvascular_parmetis_internal.h.in │ └── simvascular_parmetis_internal │ │ ├── CHANGES │ │ ├── CMakeLists.txt │ │ ├── INSTALL │ │ ├── LICENSE.txt │ │ ├── Makefile │ │ ├── Makefile.in │ │ ├── ParMETISLib │ │ ├── CMakeLists.txt │ │ ├── Makefile │ │ ├── akwayfm.c │ │ ├── ametis.c │ │ ├── balancemylink.c │ │ ├── comm.c │ │ ├── csrmatch.c │ │ ├── ctrl.c │ │ ├── debug.c │ │ ├── defs.h │ │ ├── diffutil.c │ │ ├── frename.c │ │ ├── gklib.c │ │ ├── gklib_defs.h │ │ ├── gklib_rename.h │ │ ├── gkmetis.c │ │ ├── gkmpi.c │ │ ├── graph.c │ │ ├── initbalance.c │ │ ├── initmsection.c │ │ ├── initpart.c │ │ ├── kmetis.c │ │ ├── kwayrefine.c │ │ ├── macros.h │ │ ├── match.c │ │ ├── mdiffusion.c │ │ ├── mesh.c │ │ ├── mmetis.c │ │ ├── move.c │ │ ├── msetup.c │ │ ├── node_refine.c │ │ ├── ometis.c │ │ ├── parmetis.h │ │ ├── parmetislib.h │ │ ├── proto.h │ │ ├── pspases.c │ │ ├── redomylink.c │ │ ├── remap.c │ │ ├── rename.h │ │ ├── renumber.c │ │ ├── rmetis.c │ │ ├── selectq.c │ │ ├── serial.c │ │ ├── stat.c │ │ ├── struct.h │ │ ├── temp │ │ │ ├── metis.h │ │ │ ├── metis_defs.h │ │ │ ├── parmetis.h │ │ │ └── parmetislib.h │ │ ├── timer.c │ │ ├── util.c │ │ ├── wave.c │ │ ├── weird.c │ │ ├── wspace.c │ │ └── xyzpart.c │ │ ├── README │ │ └── VERSION │ ├── share │ ├── eigen3 │ │ └── cmake │ │ │ ├── Eigen3Config.cmake │ │ │ ├── Eigen3ConfigVersion.cmake │ │ │ ├── Eigen3Targets.cmake │ │ │ └── UseEigen3.cmake │ └── pkgconfig │ │ └── eigen3.pc │ ├── tetgen │ ├── CMakeLists.txt │ ├── Makefile │ ├── simvascular_tetgen.h.in │ └── simvascular_tetgen │ │ ├── CMakeLists.txt │ │ ├── LICENSE │ │ ├── Makefile │ │ ├── README │ │ ├── README.simvascular │ │ ├── example.poly │ │ ├── makefile.tetgen.org │ │ ├── predicates.cxx │ │ ├── tetgen.cxx │ │ └── tetgen.h │ └── tinyxml │ ├── CMakeLists.txt │ ├── simvascular_tinyxml.h.in │ └── simvascular_tinyxml │ ├── CMakeLists.txt │ ├── tinyxml2.cpp │ └── tinyxml2.h ├── Distribution ├── CMakeLists.txt ├── OSX │ ├── Info.plist.in │ ├── cpmview.icns │ ├── simvascular.icns │ ├── simvascular.sh │ └── simvascular.sh.in ├── license.txt └── windows │ ├── msi-banner.bmp │ ├── msi-banner.jpg │ ├── msi-dialog.bmp │ ├── msi-dialog.jpg │ ├── mywix.template-notargets.in │ ├── mywix.template.in │ ├── registry-patch-notargets.xml.in │ ├── registry-patch.xml.in │ └── simvascular.ico ├── Docker ├── README.md ├── solver │ └── dockerfile └── ubuntu │ └── dockerfile ├── Documentation ├── Doxyfile ├── DoxygenLayout.xml ├── doxygen-awesome.css ├── internal.md └── references.bib ├── Externals ├── BuildHelpers │ ├── CompileScripts │ │ ├── compile-cmake-vtk-generic.sh │ │ ├── compile-make-tcl-generic.sh │ │ ├── sed-script-x64_cygwin-options-cl.sh │ │ ├── sed-script-x64_linux-options-gcc.sh │ │ ├── sed-script-x64_mac_osx-options-clang.sh │ │ ├── tcl-linux-generic.sh │ │ ├── tcl-mac_osx-generic.sh │ │ ├── tcl-mingw64-generic.sh │ │ ├── tcl-osx-generic.sh │ │ └── tcl-windows-generic.sh │ ├── CygwinHelpers │ │ ├── clean-env.sh │ │ ├── msvc_2010_x64 │ │ └── msvc_2013_x64 │ ├── Patches │ │ ├── patch-source-tcltk-8.5.sh │ │ ├── patch-source-vtk-6.2.sh │ │ ├── patch-source-vtk-6.3.sh │ │ ├── tk-8.5.18-win-ttkWinXPTheme.c │ │ ├── vtk-6.2.0-IO-Video-vtkWin32VideoSource.cxx.from-master-2015-07-20 │ │ ├── vtk-6.2.0-ThirdParty-TclTk-internals-tk8.5-tkWinPort.h │ │ ├── vtk-6.2.0-ThirdParty-hdf5-vtkhdf5-src-H5system.c │ │ ├── vtk-6.2.0-ThirdParty-hdf5-vtkhdf5-src-H5win32defs.h │ │ ├── vtk-6.3.0-ThirdParty-TclTk-internals-tk8.5-tkWinPort.h │ │ ├── vtk-6.3.0-ThirdParty-hdf5-vtkhdf5-src-H5system.c │ │ └── vtk-6.3.0-ThirdParty-hdf5-vtkhdf5-src-H5win32defs.h │ └── Scripts │ │ ├── create-archives-generic.sh │ │ ├── superbuild-linux-gcc.sh │ │ ├── superbuild-mac_osx-clang.sh │ │ ├── superbuild-windows-cl.sh │ │ ├── tar-to-zip-all.sh │ │ └── untar-unzip-source-all.sh ├── CMakeExternals │ └── SvExtOptions.cmake ├── CMakeLists.txt ├── build-sv-externals-helper-wget-generic.sh ├── build-sv-externals-linux.sh ├── build-sv-externals-mac_osx.sh └── build-sv-externals-windows.sh ├── LICENSE.txt ├── Licenses ├── ExternalOpenSourcePackages │ ├── README-external-licenses-academic-use-only.txt │ ├── README-external-licenses-gpl.txt │ ├── README-external-licenses-lgpl.txt │ └── README-external-licenses-unrestrictive.txt └── LesLib │ └── README-LESLIB.txt ├── README.md ├── tests ├── README.md ├── __init__.py ├── cases │ ├── cep │ │ ├── cable_TTP_1d │ │ │ ├── README.md │ │ │ ├── mesh │ │ │ │ ├── .gitattributes │ │ │ │ ├── bar_h0.40.vtu │ │ │ │ └── domain_info_h0.40.dat │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── niederer_benchmark_ECGs_quadrature │ │ │ ├── mesh │ │ │ │ ├── h0.1 │ │ │ │ │ ├── domain_info.dat │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ │ ├── X0.vtp │ │ │ │ │ │ ├── X1.vtp │ │ │ │ │ │ ├── Y0.vtp │ │ │ │ │ │ ├── Y1.vtp │ │ │ │ │ │ ├── Z0.vtp │ │ │ │ │ │ └── Z1.vtp │ │ │ │ ├── x_coords.dat │ │ │ │ ├── y_coords.dat │ │ │ │ └── z_coords.dat │ │ │ ├── result_BICG_CN_epicardium_BO_001.vtu │ │ │ ├── result_CG_RK4_myocardium_BO_001.vtu │ │ │ ├── result_GMRES_FE_epicardium_TTP_001.vtu │ │ │ ├── result_GMRES_FE_pfib_AP_001.vtu │ │ │ ├── solver_BICG_CN_epicardium_BO.xml │ │ │ ├── solver_CG_RK4_myocardium_BO.xml │ │ │ ├── solver_GMRES_FE_epicardium_TTP.xml │ │ │ └── solver_GMRES_FE_pfib_AP.xml │ │ ├── purkinje │ │ │ ├── README.md │ │ │ ├── activation_10fps.gif │ │ │ ├── mesh │ │ │ │ ├── domain_pfib_LV.dat │ │ │ │ ├── domain_pfib_RV.dat │ │ │ │ ├── pfib_LV.vtu │ │ │ │ └── pfib_RV.vtu │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── spiral_BO_2d │ │ │ ├── BO_S1S2_spiral_Ts470.0300.png │ │ │ ├── README.md │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── X0.vtp │ │ │ │ │ ├── X1.vtp │ │ │ │ │ ├── Y0.vtp │ │ │ │ │ └── Y1.vtp │ │ │ │ └── spiral_domain_info.dat │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ └── square_AP_2d │ │ │ ├── README.md │ │ │ ├── mesh │ │ │ ├── domain_info.dat │ │ │ ├── mesh-complete.mesh.vtu │ │ │ ├── mesh-surfaces │ │ │ │ ├── bottom.vtp │ │ │ │ ├── left.vtp │ │ │ │ ├── right.vtp │ │ │ │ └── top.vtp │ │ │ └── spiral_domain_info.dat │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ ├── cmm │ │ ├── iliac_artery_variable_wall_props │ │ │ ├── 1-rigid-solution │ │ │ │ ├── result_900.vtu │ │ │ │ ├── rigid_wall_mean_traction.vtp │ │ │ │ └── solver.xml │ │ │ ├── 2-inflate │ │ │ │ ├── result_003.vtu │ │ │ │ └── solver.xml │ │ │ ├── 3-inflate-cmm │ │ │ │ ├── result_003.vtu │ │ │ │ └── solver.xml │ │ │ ├── README.md │ │ │ ├── bct.vtp │ │ │ └── svMultiPhysics_var_wall_props.vtp │ │ └── pipe_3d │ │ │ ├── 1-rigid-solution │ │ │ ├── calcMeanPressTrac.py │ │ │ ├── result_800.vtu │ │ │ ├── rigid_wall_mean_pressure.vtp │ │ │ ├── rigid_wall_mean_traction.vtp │ │ │ └── solver.xml │ │ │ ├── 2a-inflate │ │ │ ├── result_003.vtu │ │ │ └── solver.xml │ │ │ ├── 2b-prestress │ │ │ ├── result_003.vtu │ │ │ └── solver.xml │ │ │ ├── 3a-inflate-cmm │ │ │ ├── result_005.vtu │ │ │ └── solver.xml │ │ │ ├── 3b-prestress-cmm │ │ │ ├── result_005.vtu │ │ │ └── solver.xml │ │ │ ├── README.md │ │ │ └── lumen_inlet.flow │ ├── fluid │ │ ├── carreau_yasuda │ │ │ ├── Compare_nonNewtonian_models.png │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── casson │ │ │ ├── Compare_nonNewtonian_models.png │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── driven_cavity_2d │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ ├── result_002.vtu │ │ │ └── solver.xml │ │ ├── driven_cavity_2d_porous │ │ │ ├── mesh │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── square_mesh_full_bottom.vtp │ │ │ │ │ ├── square_mesh_full_left.vtp │ │ │ │ │ ├── square_mesh_full_right.vtp │ │ │ │ │ └── square_mesh_full_top.vtp │ │ │ │ ├── square_mesh_full.vtu │ │ │ │ └── square_mesh_full_domain_ids.dat │ │ │ ├── result_002.vtu │ │ │ └── solver.xml │ │ ├── dye_AD │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── iliac_artery │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── cap_aorta.vtp │ │ │ │ │ ├── cap_aorta_2.vtp │ │ │ │ │ ├── cap_right_iliac.vtp │ │ │ │ │ ├── wall_aorta.vtp │ │ │ │ │ └── wall_right_iliac.vtp │ │ │ │ └── walls_combined.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── iliac_artery_trilinos_gmres_ilut │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── cap_aorta.vtp │ │ │ │ │ ├── cap_aorta_2.vtp │ │ │ │ │ ├── cap_right_iliac.vtp │ │ │ │ │ ├── wall_aorta.vtp │ │ │ │ │ └── wall_right_iliac.vtp │ │ │ │ └── walls_combined.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── newtonian │ │ │ ├── Compare_nonNewtonian_models.png │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── pipe_RCR_3d │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_002.vtu │ │ │ └── solver.xml │ │ ├── pipe_RCR_3d_fourier_coeff │ │ │ ├── README.md │ │ │ ├── fft_reconstruction.png │ │ │ ├── lumen_inlet.fcs │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_002.vtu │ │ │ └── solver.xml │ │ ├── pipe_RCR_3d_petsc │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_002.vtu │ │ │ └── solver.xml │ │ ├── pipe_RCR_3d_trilinos_bj │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_002.vtu │ │ │ └── solver.xml │ │ ├── pipe_RCR_3d_trilinos_ilut │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_002.vtu │ │ │ └── solver.xml │ │ ├── pipe_RCR_genBC │ │ │ ├── README.md │ │ │ ├── genBC │ │ │ │ ├── Makefile │ │ │ │ ├── Makefile.in │ │ │ │ └── src │ │ │ │ │ ├── GenBC.f │ │ │ │ │ ├── Modules.f │ │ │ │ │ └── USER.f │ │ │ ├── lumen_inlet.flw │ │ │ ├── mesh-complete │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ │ └── walls_combined.vtp │ │ │ ├── result_002.vtu │ │ │ ├── solver.xml │ │ │ └── validate_analytical.ipynb │ │ ├── pipe_RCR_sv0D │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flw │ │ │ ├── mesh-complete │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ │ └── walls_combined.vtp │ │ │ ├── result_002.vtu │ │ │ ├── solver.xml │ │ │ ├── svzerod_3Dcoupling.json │ │ │ └── validate_analytical.ipynb │ │ ├── pipe_RCR_weak_dir_3d │ │ │ ├── README.md │ │ │ ├── lumen_inlet.flow │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ ├── result_002.vtu │ │ │ └── solver.xml │ │ ├── precomputed_dye_AD │ │ │ ├── README.md │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── lumen_inlet.vtp │ │ │ │ │ ├── lumen_outlet.vtp │ │ │ │ │ └── lumen_wall.vtp │ │ │ │ └── walls_combined.vtp │ │ │ ├── precomputed_velocity.vtu │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ └── quadratic_tet10 │ │ │ ├── quad-mesh-complete │ │ │ ├── mesh-complete.mesh.vtu │ │ │ ├── mesh-surfaces │ │ │ │ ├── RPA6.vtu │ │ │ │ ├── RPA61.vtu │ │ │ │ ├── inflow.vtu │ │ │ │ ├── wall_RPA6.vtu │ │ │ │ ├── wall_RPA61.vtu │ │ │ │ └── wall_blend_RPA6_RPA61.vtu │ │ │ └── walls_combined.vtu │ │ │ ├── result_003.vtu │ │ │ └── solver.xml │ ├── fsi │ │ ├── pipe_3d │ │ │ ├── README.md │ │ │ ├── configuration.png │ │ │ ├── mesh │ │ │ │ ├── fluid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ │ ├── end.vtp │ │ │ │ │ │ ├── interface.vtp │ │ │ │ │ │ └── start.vtp │ │ │ │ └── solid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── end.vtp │ │ │ │ │ ├── interface.vtp │ │ │ │ │ ├── outside.vtp │ │ │ │ │ └── start.vtp │ │ │ ├── result_005.vtu │ │ │ ├── results.gif │ │ │ └── solver.xml │ │ ├── pipe_3d_petsc │ │ │ ├── README.md │ │ │ ├── configuration.png │ │ │ ├── mesh │ │ │ │ ├── fluid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ │ ├── end.vtp │ │ │ │ │ │ ├── interface.vtp │ │ │ │ │ │ └── start.vtp │ │ │ │ └── solid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── end.vtp │ │ │ │ │ ├── interface.vtp │ │ │ │ │ ├── outside.vtp │ │ │ │ │ └── start.vtp │ │ │ ├── result_005.vtu │ │ │ ├── results.gif │ │ │ └── solver.xml │ │ ├── pipe_3d_trilinos_bj │ │ │ ├── README.md │ │ │ ├── configuration.png │ │ │ ├── mesh │ │ │ │ ├── fluid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ │ ├── end.vtp │ │ │ │ │ │ ├── interface.vtp │ │ │ │ │ │ └── start.vtp │ │ │ │ └── solid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── end.vtp │ │ │ │ │ ├── interface.vtp │ │ │ │ │ ├── outside.vtp │ │ │ │ │ └── start.vtp │ │ │ ├── result_005.vtu │ │ │ ├── results.gif │ │ │ └── solver.xml │ │ ├── pipe_3d_trilinos_ml │ │ │ ├── README.md │ │ │ ├── configuration.png │ │ │ ├── mesh │ │ │ │ ├── fluid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ │ ├── end.vtp │ │ │ │ │ │ ├── interface.vtp │ │ │ │ │ │ └── start.vtp │ │ │ │ └── solid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── end.vtp │ │ │ │ │ ├── interface.vtp │ │ │ │ │ ├── outside.vtp │ │ │ │ │ └── start.vtp │ │ │ ├── result_005.vtu │ │ │ ├── results.gif │ │ │ └── solver.xml │ │ └── pipe_RCR_3d │ │ │ ├── README.md │ │ │ ├── mesh │ │ │ ├── fluid │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── end.vtp │ │ │ │ │ ├── interface.vtp │ │ │ │ │ └── start.vtp │ │ │ └── solid │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ ├── end.vtp │ │ │ │ ├── interface.vtp │ │ │ │ ├── outside.vtp │ │ │ │ └── start.vtp │ │ │ ├── result_005.vtu │ │ │ └── solver.xml │ ├── fsi_ustruct │ │ ├── pipe_3d │ │ │ ├── README.md │ │ │ ├── mesh │ │ │ │ ├── fluid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ │ ├── end.vtp │ │ │ │ │ │ ├── interface.vtp │ │ │ │ │ │ └── start.vtp │ │ │ │ └── solid │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── end.vtp │ │ │ │ │ ├── interface.vtp │ │ │ │ │ ├── outside.vtp │ │ │ │ │ └── start.vtp │ │ │ ├── result_005.vtu │ │ │ └── solver.xml │ │ └── pipe_RCR_3d │ │ │ ├── README.md │ │ │ ├── mesh │ │ │ ├── fluid │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── end.vtp │ │ │ │ │ ├── interface.vtp │ │ │ │ │ └── start.vtp │ │ │ └── solid │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ ├── end.vtp │ │ │ │ ├── interface.vtp │ │ │ │ ├── outside.vtp │ │ │ │ └── start.vtp │ │ │ ├── result_005.vtu │ │ │ └── solver.xml │ ├── heats │ │ └── diffusion_line_source │ │ │ ├── README.md │ │ │ ├── bc_left.dat │ │ │ ├── mesh │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── bottom.vtp │ │ │ │ ├── left.vtp │ │ │ │ ├── right.vtp │ │ │ │ └── top.vtp │ │ │ ├── plot-temp-flux.png │ │ │ ├── result_002.vtu │ │ │ ├── solver_BICG.xml │ │ │ ├── solver_CG.xml │ │ │ └── solver_GMRES.xml │ ├── linear-elasticity │ │ └── beam │ │ │ ├── README.md │ │ │ ├── load.dat │ │ │ ├── mesh │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── back.vtp │ │ │ │ ├── bottom.vtp │ │ │ │ ├── front.vtp │ │ │ │ ├── left.vtp │ │ │ │ ├── right.vtp │ │ │ │ └── top.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ ├── ris │ │ └── pipe_ris_3d │ │ │ ├── README.md │ │ │ ├── inlet.dat │ │ │ ├── mesh │ │ │ ├── 1-mesh-complete │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── noname_1.vtp │ │ │ │ │ ├── noname_2.vtp │ │ │ │ │ └── noname_3.vtp │ │ │ └── 2-mesh-complete │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ ├── noname_1.vtp │ │ │ │ ├── noname_2.vtp │ │ │ │ └── noname_3.vtp │ │ │ ├── result_005.vtu │ │ │ └── solver.xml │ ├── shell │ │ ├── plate │ │ │ ├── mesh │ │ │ │ ├── 2Dsqr_NURBS_C1.msh │ │ │ │ └── tri3 │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── x0.vtp │ │ │ │ │ ├── x1.vtp │ │ │ │ │ ├── y0.vtp │ │ │ │ │ └── y1.vtp │ │ │ ├── result_010.vtu │ │ │ └── solver.xml │ │ └── valve │ │ │ ├── leaflet_deform_20fps.avi │ │ │ ├── mesh │ │ │ ├── PAT003_07_LCC.vtu │ │ │ ├── PAT003_07_NCC.vtu │ │ │ ├── PAT003_07_RCC.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── PAT003_07_LCC_edge1.vtp │ │ │ │ ├── PAT003_07_LCC_edge2.vtp │ │ │ │ ├── PAT003_07_NCC_edge1.vtp │ │ │ │ ├── PAT003_07_NCC_edge2.vtp │ │ │ │ ├── PAT003_07_RCC_edge1.vtp │ │ │ │ └── PAT003_07_RCC_edge2.vtp │ │ │ ├── pbc.dat │ │ │ ├── pbc_t.png │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ ├── stokes │ │ └── manufactured_solution │ │ │ ├── P1P1 │ │ │ ├── N004 │ │ │ │ ├── result_250.vtu │ │ │ │ └── solver.xml │ │ │ ├── N008 │ │ │ │ ├── result_250.vtu │ │ │ │ └── solver.xml │ │ │ ├── N016 │ │ │ │ ├── result_250.vtu │ │ │ │ └── solver.xml │ │ │ ├── N032 │ │ │ │ ├── result_250.vtu │ │ │ │ └── solver.xml │ │ │ ├── N064 │ │ │ │ ├── result_250.vtu │ │ │ │ └── solver.xml │ │ │ ├── N128 │ │ │ │ ├── result_250.vtu │ │ │ │ └── solver.xml │ │ │ ├── N256 │ │ │ │ ├── result_250.vtu │ │ │ │ └── solver.xml │ │ │ ├── bforce │ │ │ │ ├── N004 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bforce.vtu │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N008 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bforce.vtu │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N016 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bforce.vtu │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N032 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bforce.vtu │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N064 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bforce.vtu │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N128 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bforce.vtu │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N256 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bforce.vtu │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ └── src │ │ │ │ │ ├── calc_bforce.py │ │ │ │ │ ├── calc_dir_bc.py │ │ │ │ │ ├── calc_exact_soln.py │ │ │ │ │ ├── gen_bforce_dat.m │ │ │ │ │ └── gen_dir_bc_dat.m │ │ │ ├── l2norm │ │ │ │ ├── error_L2_P1P1_bfC0.png │ │ │ │ ├── in_L2.dat │ │ │ │ ├── l2norm_p.dat │ │ │ │ ├── l2norm_v.dat │ │ │ │ └── plot_error.m │ │ │ └── mesh │ │ │ │ ├── N004 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ ├── N008 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ ├── N016 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ ├── N032 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ ├── N064 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ ├── N128 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ └── N256 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ ├── bottom.vtp │ │ │ │ ├── left.vtp │ │ │ │ ├── right.vtp │ │ │ │ └── top.vtp │ │ │ ├── P2P1 │ │ │ ├── N004 │ │ │ │ ├── result_050.vtu │ │ │ │ └── solver.xml │ │ │ ├── N008 │ │ │ │ ├── result_050.vtu │ │ │ │ └── solver.xml │ │ │ ├── N016 │ │ │ │ ├── result_050.vtu │ │ │ │ └── solver.xml │ │ │ ├── N032 │ │ │ │ ├── result_050.vtu │ │ │ │ └── solver.xml │ │ │ ├── N064 │ │ │ │ ├── result_050.vtu │ │ │ │ └── solver.xml │ │ │ ├── N128 │ │ │ │ ├── result_050.vtu │ │ │ │ └── solver.xml │ │ │ ├── bforce │ │ │ │ ├── N004 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N008 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N016 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N032 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N064 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── N128 │ │ │ │ │ ├── bforce.dat │ │ │ │ │ ├── bottom_vbc.dat │ │ │ │ │ ├── exact_soln.vtu │ │ │ │ │ ├── left_vbc.dat │ │ │ │ │ ├── right_vbc.dat │ │ │ │ │ └── top_vbc.dat │ │ │ │ ├── bforce.vtu │ │ │ │ └── src │ │ │ │ │ ├── calc_bforce.py │ │ │ │ │ ├── calc_dir_bc.py │ │ │ │ │ ├── calc_exact_soln.py │ │ │ │ │ ├── gen_bforce_dat.m │ │ │ │ │ └── gen_dir_bc_dat.m │ │ │ ├── l2norm │ │ │ │ ├── error_L2_P2P1.png │ │ │ │ ├── in_L2.dat │ │ │ │ ├── l2norm_p.dat │ │ │ │ ├── l2norm_v.dat │ │ │ │ └── plot_error.m │ │ │ └── mesh │ │ │ │ ├── N004 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ ├── N008 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ ├── N016 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ ├── N032 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ ├── N064 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── bottom.vtp │ │ │ │ │ ├── left.vtp │ │ │ │ │ ├── right.vtp │ │ │ │ │ └── top.vtp │ │ │ │ └── N128 │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ ├── bottom.vtp │ │ │ │ ├── left.vtp │ │ │ │ ├── right.vtp │ │ │ │ └── top.vtp │ │ │ └── README.md │ ├── struct │ │ ├── LV_CANN_artery_material_model │ │ │ ├── endo_pressure.dat │ │ │ ├── mesh │ │ │ │ ├── fibersLongCells.vtu │ │ │ │ ├── fibersSheetCells.vtu │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── endo.vtp │ │ │ │ │ ├── epi.vtp │ │ │ │ │ └── top.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── LV_Guccione_passive │ │ │ ├── load.dat │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── base.vtp │ │ │ │ │ ├── endo.vtp │ │ │ │ │ └── epi.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── LV_HolzapfelOgdenModifiedAnisotropy_passive │ │ │ ├── endo_pressure.dat │ │ │ ├── mesh │ │ │ │ ├── fibersLongCells.vtu │ │ │ │ ├── fibersSheetCells.vtu │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── endo.vtp │ │ │ │ │ ├── epi.vtp │ │ │ │ │ └── top.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── LV_HolzapfelOgden_active │ │ │ ├── LV_stress.dat │ │ │ ├── README.md │ │ │ ├── comparison_plots_p0_p1_step_1_nonblinded.png │ │ │ ├── figures.py │ │ │ ├── generate_pressure.py │ │ │ ├── mesh │ │ │ │ ├── fibersLong.vtu │ │ │ │ ├── fibersSheet.vtu │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── endo.vtp │ │ │ │ │ ├── epi.vtp │ │ │ │ │ └── top.vtp │ │ │ ├── p-v_loop.png │ │ │ ├── pressure.dat │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── LV_HolzapfelOgden_passive │ │ │ ├── endo_pressure.dat │ │ │ ├── mesh │ │ │ │ ├── fibersLongCells.vtu │ │ │ │ ├── fibersSheetCells.vtu │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── endo.vtp │ │ │ │ │ ├── epi.vtp │ │ │ │ │ └── top.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── LV_HolzapfelOgden_passive_CANN │ │ │ ├── endo_pressure.dat │ │ │ ├── mesh │ │ │ │ ├── fibersLongCells.vtu │ │ │ │ ├── fibersSheetCells.vtu │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── endo.vtp │ │ │ │ │ ├── epi.vtp │ │ │ │ │ └── top.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── LV_HolzapfelOgden_passive_k0 │ │ │ ├── endo_pressure.dat │ │ │ ├── mesh │ │ │ │ ├── fibersLongCells.vtu │ │ │ │ ├── fibersSheetCells.vtu │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── endo.vtp │ │ │ │ │ ├── epi.vtp │ │ │ │ │ └── top.vtp │ │ │ └── solver.xml │ │ ├── LV_NeoHookean_passive │ │ │ ├── README.md │ │ │ ├── endo_pressure.dat │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── endo.vtp │ │ │ │ │ ├── epi.vtp │ │ │ │ │ └── top.vtp │ │ │ ├── result_005.vtu │ │ │ └── solver.xml │ │ ├── LV_NeoHookean_passive_genBC │ │ │ ├── README.md │ │ │ ├── V3D_vs_V0D.png │ │ │ ├── dVdt3D_vs_dVdt0D.png │ │ │ ├── genBC │ │ │ │ ├── Makefile │ │ │ │ ├── Makefile.in │ │ │ │ ├── include │ │ │ │ │ ├── initial_values_final.f │ │ │ │ │ └── parameters_final.f │ │ │ │ └── src │ │ │ │ │ ├── GenBC.f │ │ │ │ │ ├── Modules.f │ │ │ │ │ └── USER.f │ │ │ ├── genBC_svMultiPhysics │ │ │ │ ├── Makefile │ │ │ │ ├── Makefile.in │ │ │ │ ├── include │ │ │ │ │ ├── initial_values_final.f │ │ │ │ │ └── parameters_final.f │ │ │ │ └── src │ │ │ │ │ ├── GenBC.f │ │ │ │ │ ├── Modules.f │ │ │ │ │ └── USER.f │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── endo.vtp │ │ │ │ │ ├── epi.vtp │ │ │ │ │ └── top.vtp │ │ │ ├── post_processing_functions.py │ │ │ ├── process_results.py │ │ │ ├── pv_plot.png │ │ │ ├── result_003.vtu │ │ │ └── solver.xml │ │ ├── LV_NeoHookean_passive_sv0D │ │ │ ├── README.md │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── endo.vtp │ │ │ │ │ ├── epi.vtp │ │ │ │ │ └── top.vtp │ │ │ ├── result_003.vtu │ │ │ ├── solver.xml │ │ │ └── svzerod_3Dcoupling.json │ │ ├── block_compression │ │ │ ├── README.md │ │ │ ├── load.dat │ │ │ ├── mesh │ │ │ │ └── P1 │ │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── X0.vtp │ │ │ │ │ ├── X1.vtp │ │ │ │ │ ├── Y0.vtp │ │ │ │ │ ├── Y1.vtp │ │ │ │ │ ├── Z0.vtp │ │ │ │ │ └── Z1.vtp │ │ │ │ │ └── paraview_mesh_surface.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── block_compression_CANN │ │ │ ├── load.dat │ │ │ ├── mesh │ │ │ │ └── P1 │ │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── X0.vtp │ │ │ │ │ ├── X1.vtp │ │ │ │ │ ├── Y0.vtp │ │ │ │ │ ├── Y1.vtp │ │ │ │ │ ├── Z0.vtp │ │ │ │ │ └── Z1.vtp │ │ │ │ │ └── paraview_mesh_surface.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── robin │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── end.vtp │ │ │ │ │ ├── interface.vtp │ │ │ │ │ ├── outside.vtp │ │ │ │ │ └── start.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── spatially_variable_robin │ │ │ ├── README.md │ │ │ ├── Y0_spatially_varying_robin.png │ │ │ ├── Y0_spatially_varying_robin.vtp │ │ │ ├── animation.avi │ │ │ ├── animation.gif │ │ │ ├── load.dat │ │ │ ├── load.png │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── X0.vtp │ │ │ │ │ ├── X1.vtp │ │ │ │ │ ├── Y0.vtp │ │ │ │ │ ├── Y1.vtp │ │ │ │ │ ├── Z0.vtp │ │ │ │ │ └── Z1.vtp │ │ │ ├── result_002.vtu │ │ │ └── solver.xml │ │ ├── tensile_adventitia_Guccione_active │ │ │ ├── README.md │ │ │ ├── generate_stress.py │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── X0.vtp │ │ │ │ │ ├── X1.vtp │ │ │ │ │ ├── Y0.vtp │ │ │ │ │ ├── Y1.vtp │ │ │ │ │ ├── Z0.vtp │ │ │ │ │ └── Z1.vtp │ │ │ ├── movie.gif │ │ │ ├── movie.mp4 │ │ │ ├── result_002.vtu │ │ │ ├── solver.xml │ │ │ ├── stress.dat │ │ │ └── stress.png │ │ ├── tensile_adventitia_Newtonian_viscosity │ │ │ ├── README.md │ │ │ ├── generate_load.py │ │ │ ├── load.dat │ │ │ ├── load.png │ │ │ ├── mesh │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ │ ├── X0.vtp │ │ │ │ │ ├── X1.vtp │ │ │ │ │ ├── Y0.vtp │ │ │ │ │ ├── Y1.vtp │ │ │ │ │ ├── Z0.vtp │ │ │ │ │ └── Z1.vtp │ │ │ ├── movie.avi │ │ │ ├── movie.gif │ │ │ ├── plot_z1_face_displacement.py │ │ │ ├── result_001.vtu │ │ │ ├── solver.xml │ │ │ ├── z1_face_displacement.dat │ │ │ ├── z1_face_displacement.png │ │ │ └── z1_face_displacement_no_viscosity.dat │ │ └── tensile_adventitia_Potential_viscosity │ │ │ ├── README.md │ │ │ ├── generate_load.py │ │ │ ├── load.dat │ │ │ ├── load.png │ │ │ ├── mesh │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── X0.vtp │ │ │ │ ├── X1.vtp │ │ │ │ ├── Y0.vtp │ │ │ │ ├── Y1.vtp │ │ │ │ ├── Z0.vtp │ │ │ │ └── Z1.vtp │ │ │ ├── movie.avi │ │ │ ├── movie.gif │ │ │ ├── plot_z1_face_displacement.py │ │ │ ├── result_001.vtu │ │ │ ├── solver.xml │ │ │ ├── z1_face_displacement.dat │ │ │ ├── z1_face_displacement.png │ │ │ └── z1_face_displacement_no_viscosity.dat │ ├── uris │ │ └── pipe_uris_3d │ │ │ ├── README.md │ │ │ ├── meshes │ │ │ ├── PAT003_07_LCC_morphed+25.vtu │ │ │ ├── PAT003_07_LCC_morphed+25motion_close.dat │ │ │ ├── PAT003_07_LCC_morphed+25motion_open.dat │ │ │ ├── PAT003_07_LCC_morphed-25.vtu │ │ │ ├── PAT003_07_LCC_morphed-25motion_close.dat │ │ │ ├── PAT003_07_LCC_morphed-25motion_open.dat │ │ │ ├── PAT003_07_NCC_morphed+25.vtu │ │ │ ├── PAT003_07_NCC_morphed+25motion_close.dat │ │ │ ├── PAT003_07_NCC_morphed+25motion_open.dat │ │ │ ├── PAT003_07_NCC_morphed-25.vtu │ │ │ ├── PAT003_07_NCC_morphed-25motion_close.dat │ │ │ ├── PAT003_07_NCC_morphed-25motion_open.dat │ │ │ ├── PAT003_07_RCC_morphed+25.vtu │ │ │ ├── PAT003_07_RCC_morphed+25motion_close.dat │ │ │ ├── PAT003_07_RCC_morphed+25motion_open.dat │ │ │ ├── PAT003_07_RCC_morphed-25.vtu │ │ │ ├── PAT003_07_RCC_morphed-25motion_close.dat │ │ │ ├── PAT003_07_RCC_morphed-25motion_open.dat │ │ │ ├── cylinder-mesh-complete │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ ├── mesh-surfaces │ │ │ │ │ ├── noname_1.vtp │ │ │ │ │ ├── noname_2.vtp │ │ │ │ │ └── noname_3.vtp │ │ │ │ └── motion │ │ │ │ │ └── motion_awave │ │ │ │ │ └── mesh-complete │ │ │ │ │ ├── 1_displacement.dat │ │ │ │ │ ├── 2_displacement.dat │ │ │ │ │ └── 3_displacement.dat │ │ │ └── normal.dat │ │ │ ├── result_005.vtu │ │ │ └── solver.xml │ └── ustruct │ │ ├── LV_Guccione_active │ │ ├── README.md │ │ ├── animation.avi │ │ ├── animation.gif │ │ ├── fib_stress.dat │ │ ├── load.dat │ │ ├── mesh │ │ │ └── P1 │ │ │ │ ├── calcfiber.py │ │ │ │ ├── fibersLong.vtu │ │ │ │ ├── fibersSheet.vtu │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ ├── mesh-surfaces │ │ │ │ ├── base.vtp │ │ │ │ ├── endo.vtp │ │ │ │ └── epi.vtp │ │ │ │ └── phi.vtu │ │ ├── result_001.vtu │ │ └── solver.xml │ │ ├── LV_HolzapfelOgdenModifiedAnisotropy_passive │ │ ├── endo_pressure.dat │ │ ├── mesh │ │ │ ├── fibersLongCells.vtu │ │ │ ├── fibersSheetCells.vtu │ │ │ ├── mesh-complete.exterior.vtp │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── endo.vtp │ │ │ │ ├── epi.vtp │ │ │ │ └── top.vtp │ │ ├── result_001.vtu │ │ └── solver.xml │ │ ├── LV_HolzapfelOgdenModifiedAnisotropy_passive_trilinos │ │ ├── endo_pressure.dat │ │ ├── mesh │ │ │ ├── fibersLongCells.vtu │ │ │ ├── fibersSheetCells.vtu │ │ │ ├── mesh-complete.exterior.vtp │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── endo.vtp │ │ │ │ ├── epi.vtp │ │ │ │ └── top.vtp │ │ ├── result_001.vtu │ │ └── solver.xml │ │ ├── LV_HolzapfelOgden_active │ │ ├── LV_stress.dat │ │ ├── README.md │ │ ├── comparison_plots_p0_p1_step_1_nonblinded.png │ │ ├── figures.py │ │ ├── generate_pressure.py │ │ ├── mesh │ │ │ ├── fibersLong.vtu │ │ │ ├── fibersSheet.vtu │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── endo.vtp │ │ │ │ ├── epi.vtp │ │ │ │ └── top.vtp │ │ ├── p-v_loop.png │ │ ├── pressure.dat │ │ ├── result_001.vtu │ │ └── solver.xml │ │ ├── LV_HolzapfelOgden_passive │ │ ├── endo_pressure.dat │ │ ├── mesh │ │ │ ├── fibersLongCells.vtu │ │ │ ├── fibersSheetCells.vtu │ │ │ ├── mesh-complete.exterior.vtp │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── endo.vtp │ │ │ │ ├── epi.vtp │ │ │ │ └── top.vtp │ │ ├── result_001.vtu │ │ └── solver.xml │ │ ├── LV_NeoHookean_passive_genBC │ │ ├── README.md │ │ ├── V3D_vs_V0D.png │ │ ├── dVdt3D_vs_dVdt0D.png │ │ ├── genBC │ │ │ ├── Makefile │ │ │ ├── Makefile.in │ │ │ ├── include │ │ │ │ ├── initial_values_final.f │ │ │ │ └── parameters_final.f │ │ │ └── src │ │ │ │ ├── GenBC.f │ │ │ │ ├── Modules.f │ │ │ │ └── USER.f │ │ ├── genBC_svMultiPhysics │ │ │ ├── Makefile │ │ │ ├── Makefile.in │ │ │ ├── include │ │ │ │ ├── initial_values_final.f │ │ │ │ └── parameters_final.f │ │ │ └── src │ │ │ │ ├── GenBC.f │ │ │ │ ├── Modules.f │ │ │ │ └── USER.f │ │ ├── mesh │ │ │ ├── mesh-complete.exterior.vtp │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── endo.vtp │ │ │ │ ├── epi.vtp │ │ │ │ └── top.vtp │ │ ├── post_processing_functions.py │ │ ├── process_results.py │ │ ├── pv_plot.png │ │ ├── result_003.vtu │ │ └── solver.xml │ │ ├── LV_NeoHookean_passive_sv0D │ │ ├── README.md │ │ ├── mesh │ │ │ ├── mesh-complete.exterior.vtp │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── endo.vtp │ │ │ │ ├── epi.vtp │ │ │ │ └── top.vtp │ │ ├── result_003.vtu │ │ ├── solver.xml │ │ └── svzerod_3Dcoupling.json │ │ ├── block_compression │ │ └── P1P1_VMS │ │ │ ├── load.dat │ │ │ ├── mesh │ │ │ └── cube-mesh-complete │ │ │ │ ├── mesh-complete.exterior.vtp │ │ │ │ ├── mesh-complete.mesh.vtu │ │ │ │ └── mesh-surfaces │ │ │ │ ├── X0.vtp │ │ │ │ ├── X1.vtp │ │ │ │ ├── Y0.vtp │ │ │ │ ├── Y1.vtp │ │ │ │ ├── Z0.vtp │ │ │ │ └── Z1.vtp │ │ │ ├── result_001.vtu │ │ │ └── solver.xml │ │ ├── spatially_variable_robin │ │ ├── README.md │ │ ├── Y0_spatially_varying_robin.png │ │ ├── Y0_spatially_varying_robin.vtp │ │ ├── animation.avi │ │ ├── animation.gif │ │ ├── load.dat │ │ ├── load.png │ │ ├── mesh │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── X0.vtp │ │ │ │ ├── X1.vtp │ │ │ │ ├── Y0.vtp │ │ │ │ ├── Y1.vtp │ │ │ │ ├── Z0.vtp │ │ │ │ └── Z1.vtp │ │ ├── result_002.vtu │ │ └── solver.xml │ │ ├── tensile_adventitia_HGO │ │ ├── load.dat │ │ ├── mesh │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── X0.vtp │ │ │ │ ├── X1.vtp │ │ │ │ ├── Y0.vtp │ │ │ │ ├── Y1.vtp │ │ │ │ ├── Z0.vtp │ │ │ │ └── Z1.vtp │ │ ├── result_001.vtu │ │ └── solver.xml │ │ ├── tensile_adventitia_Newtonian_viscosity │ │ ├── README.md │ │ ├── generate_load.py │ │ ├── load.dat │ │ ├── load.png │ │ ├── mesh │ │ │ ├── mesh-complete.mesh.vtu │ │ │ └── mesh-surfaces │ │ │ │ ├── X0.vtp │ │ │ │ ├── X1.vtp │ │ │ │ ├── Y0.vtp │ │ │ │ ├── Y1.vtp │ │ │ │ ├── Z0.vtp │ │ │ │ └── Z1.vtp │ │ ├── movie.avi │ │ ├── movie.gif │ │ ├── plot_z1_face_displacement.py │ │ ├── result_001.vtu │ │ ├── solver.xml │ │ ├── z1_face_displacement.dat │ │ ├── z1_face_displacement.png │ │ └── z1_face_displacement_no_viscosity.dat │ │ └── tensile_adventitia_Potential_viscosity │ │ ├── README.md │ │ ├── generate_load.py │ │ ├── load.dat │ │ ├── load.png │ │ ├── mesh │ │ ├── mesh-complete.mesh.vtu │ │ └── mesh-surfaces │ │ │ ├── X0.vtp │ │ │ ├── X1.vtp │ │ │ ├── Y0.vtp │ │ │ ├── Y1.vtp │ │ │ ├── Z0.vtp │ │ │ └── Z1.vtp │ │ ├── movie.avi │ │ ├── movie.gif │ │ ├── plot_z1_face_displacement.py │ │ ├── result_001.vtu │ │ ├── solver.xml │ │ ├── z1_face_displacement.dat │ │ ├── z1_face_displacement.png │ │ └── z1_face_displacement_no_viscosity.dat ├── conftest.py ├── test_cep.py ├── test_cmm.py ├── test_fluid.py ├── test_fsi.py ├── test_fsi_ustruct.py ├── test_heats.py ├── test_linear_elasticity.py ├── test_ris.py ├── test_shell.py ├── test_stokes.py ├── test_struct.py ├── test_uris.py ├── test_ustruct.py └── unitTests │ ├── README.md │ ├── material_model_tests │ ├── test_material_CANN_holzapfel_ogden.cpp │ ├── test_material_CANN_holzapfel_ogden.h │ ├── test_material_CANN_neohookean.cpp │ ├── test_material_CANN_neohookean.h │ ├── test_material_common.h │ ├── test_material_holzapfel_ogden.cpp │ ├── test_material_holzapfel_ogden.h │ ├── test_material_holzapfel_ogden_MA.cpp │ ├── test_material_holzapfel_ogden_MA.h │ ├── test_material_miehe_94_volumetric_penalty.cpp │ ├── test_material_miehe_94_volumetric_penalty.h │ ├── test_material_mooney_rivlin.cpp │ ├── test_material_mooney_rivlin.h │ ├── test_material_neohookean.cpp │ ├── test_material_neohookean.h │ ├── test_material_quadratic_volumetric_penalty.cpp │ ├── test_material_quadratic_volumetric_penalty.h │ ├── test_material_simo_taylor_91_volumetric_penalty.cpp │ └── test_material_simo_taylor_91_volumetric_penalty.h │ ├── math_tests │ ├── test_fft.cpp │ └── test_fft.h │ └── test_common.h └── utilities ├── README.md ├── fourier_coefficients ├── README.md ├── fft_reconstruction.png ├── fft_temporal_values.py ├── lumen_inlet.fcs ├── lumen_inlet.flow └── requirements.txt └── generate_boundary_condition_data ├── generate_load.py └── generate_spatially_variable_robin.py /.gitattributes: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.gitattributes -------------------------------------------------------------------------------- /.github/WORKFLOW.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.github/WORKFLOW.md -------------------------------------------------------------------------------- /.github/actions/test-macos/action.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.github/actions/test-macos/action.yml -------------------------------------------------------------------------------- /.github/actions/test-ubuntu/action.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.github/actions/test-ubuntu/action.yml -------------------------------------------------------------------------------- /.github/codecov.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.github/codecov.yml -------------------------------------------------------------------------------- /.github/workflows/copyright.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.github/workflows/copyright.yml -------------------------------------------------------------------------------- /.github/workflows/docker_solver_build.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.github/workflows/docker_solver_build.yml -------------------------------------------------------------------------------- /.github/workflows/documentation.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.github/workflows/documentation.yml -------------------------------------------------------------------------------- /.github/workflows/tests.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.github/workflows/tests.yml -------------------------------------------------------------------------------- /.gitignore: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.gitignore -------------------------------------------------------------------------------- /.licenserc.json: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/.licenserc.json -------------------------------------------------------------------------------- /CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/CMakeLists.txt -------------------------------------------------------------------------------- /Code/CMake/FindINTELRUNTIME.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/FindINTELRUNTIME.cmake -------------------------------------------------------------------------------- /Code/CMake/LINEAR_SOLVERConfig.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/LINEAR_SOLVERConfig.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularDependentOptions.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularDependentOptions.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularExternals.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularExternals.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularFunctionCheckCompilerFlags.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularFunctionCheckCompilerFlags.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularFunctions.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularFunctions.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularInstallLibs.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularInstallLibs.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularInstallSetup.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularInstallSetup.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularInternals.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularInternals.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularMacros.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularMacros.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularOptions.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularOptions.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularSystemSetup.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularSystemSetup.cmake -------------------------------------------------------------------------------- /Code/CMake/SimVascularThirdParty.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/SimVascularThirdParty.cmake -------------------------------------------------------------------------------- /Code/CMake/Superbuild.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMake/Superbuild.cmake -------------------------------------------------------------------------------- /Code/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/CMakeLists.txt -------------------------------------------------------------------------------- /Code/Source/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/CMakeLists.txt -------------------------------------------------------------------------------- /Code/Source/Include/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/Include/CMakeLists.txt -------------------------------------------------------------------------------- /Code/Source/Include/SimVascular.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/Include/SimVascular.h -------------------------------------------------------------------------------- /Code/Source/Include/cvFlowsolverOptions.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/Include/cvFlowsolverOptions.h.in -------------------------------------------------------------------------------- /Code/Source/Include/simvascular_options.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/Include/simvascular_options.h.in -------------------------------------------------------------------------------- /Code/Source/Include/simvascular_version.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/Include/simvascular_version.h.in -------------------------------------------------------------------------------- /Code/Source/liner_solver/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/CMakeLists.txt -------------------------------------------------------------------------------- /Code/Source/liner_solver/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/README.md -------------------------------------------------------------------------------- /Code/Source/liner_solver/add_bc_mul.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/add_bc_mul.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/add_bc_mul.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/add_bc_mul.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/bc.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/bc.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/bcast.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/bcast.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/bcast.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/bcast.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/bicgs.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/bicgs.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/bicgs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/bicgs.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/cgrad.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/cgrad.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/cgrad.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/cgrad.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/commu.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/commu.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/commu.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/commu.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/cput.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/cput.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/dot.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/dot.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/dot.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/dot.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/fils_struct.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/fils_struct.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/fils_struct.hpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/fils_struct.hpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/fsils.hpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/fsils.hpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/fsils_api.hpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/fsils_api.hpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/fsils_std.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/fsils_std.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/ge.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/ge.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/ge.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/ge.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/gmres.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/gmres.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/gmres.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/gmres.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/in_commu.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/in_commu.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/lhs.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/lhs.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/lhs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/lhs.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/ls.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/ls.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/norm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/norm.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/norm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/norm.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/ns_solver.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/ns_solver.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/ns_solver.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/ns_solver.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/omp_la.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/omp_la.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/omp_la.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/omp_la.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/pc_gmres.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/pc_gmres.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/pc_gmres.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/pc_gmres.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/precond.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/precond.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/precond.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/precond.h -------------------------------------------------------------------------------- /Code/Source/liner_solver/solve.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/solve.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/spar_mul.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/spar_mul.cpp -------------------------------------------------------------------------------- /Code/Source/liner_solver/spar_mul.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/liner_solver/spar_mul.h -------------------------------------------------------------------------------- /Code/Source/solver/Array.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Array.cpp -------------------------------------------------------------------------------- /Code/Source/solver/Array.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Array.h -------------------------------------------------------------------------------- /Code/Source/solver/Array3.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Array3.cpp -------------------------------------------------------------------------------- /Code/Source/solver/Array3.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Array3.h -------------------------------------------------------------------------------- /Code/Source/solver/ArtificialNeuralNetMaterial.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ArtificialNeuralNetMaterial.cpp -------------------------------------------------------------------------------- /Code/Source/solver/ArtificialNeuralNetMaterial.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ArtificialNeuralNetMaterial.h -------------------------------------------------------------------------------- /Code/Source/solver/BoundaryCondition.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/BoundaryCondition.cpp -------------------------------------------------------------------------------- /Code/Source/solver/BoundaryCondition.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/BoundaryCondition.h -------------------------------------------------------------------------------- /Code/Source/solver/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CMakeLists.txt -------------------------------------------------------------------------------- /Code/Source/solver/CepMod.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepMod.cpp -------------------------------------------------------------------------------- /Code/Source/solver/CepMod.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepMod.h -------------------------------------------------------------------------------- /Code/Source/solver/CepModAp.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepModAp.cpp -------------------------------------------------------------------------------- /Code/Source/solver/CepModAp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepModAp.h -------------------------------------------------------------------------------- /Code/Source/solver/CepModBo.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepModBo.cpp -------------------------------------------------------------------------------- /Code/Source/solver/CepModBo.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepModBo.h -------------------------------------------------------------------------------- /Code/Source/solver/CepModFn.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepModFn.cpp -------------------------------------------------------------------------------- /Code/Source/solver/CepModFn.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepModFn.h -------------------------------------------------------------------------------- /Code/Source/solver/CepModTtp.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepModTtp.cpp -------------------------------------------------------------------------------- /Code/Source/solver/CepModTtp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CepModTtp.h -------------------------------------------------------------------------------- /Code/Source/solver/ChnlMod.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ChnlMod.cpp -------------------------------------------------------------------------------- /Code/Source/solver/ChnlMod.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ChnlMod.h -------------------------------------------------------------------------------- /Code/Source/solver/CmMod.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CmMod.cpp -------------------------------------------------------------------------------- /Code/Source/solver/CmMod.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/CmMod.h -------------------------------------------------------------------------------- /Code/Source/solver/ComMod.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ComMod.cpp -------------------------------------------------------------------------------- /Code/Source/solver/ComMod.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ComMod.h -------------------------------------------------------------------------------- /Code/Source/solver/DebugMsg.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/DebugMsg.h -------------------------------------------------------------------------------- /Code/Source/solver/FsilsLinearAlgebra.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/FsilsLinearAlgebra.cpp -------------------------------------------------------------------------------- /Code/Source/solver/FsilsLinearAlgebra.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/FsilsLinearAlgebra.h -------------------------------------------------------------------------------- /Code/Source/solver/LinearAlgebra.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/LinearAlgebra.cpp -------------------------------------------------------------------------------- /Code/Source/solver/LinearAlgebra.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/LinearAlgebra.h -------------------------------------------------------------------------------- /Code/Source/solver/Parameters.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Parameters.cpp -------------------------------------------------------------------------------- /Code/Source/solver/Parameters.cpp.orig: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Parameters.cpp.orig -------------------------------------------------------------------------------- /Code/Source/solver/Parameters.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Parameters.h -------------------------------------------------------------------------------- /Code/Source/solver/PetscLinearAlgebra.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/PetscLinearAlgebra.cpp -------------------------------------------------------------------------------- /Code/Source/solver/PetscLinearAlgebra.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/PetscLinearAlgebra.h -------------------------------------------------------------------------------- /Code/Source/solver/README-trilinos.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/README-trilinos.md -------------------------------------------------------------------------------- /Code/Source/solver/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/README.md -------------------------------------------------------------------------------- /Code/Source/solver/RobinBoundaryCondition.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/RobinBoundaryCondition.cpp -------------------------------------------------------------------------------- /Code/Source/solver/RobinBoundaryCondition.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/RobinBoundaryCondition.h -------------------------------------------------------------------------------- /Code/Source/solver/SPLIT.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/SPLIT.c -------------------------------------------------------------------------------- /Code/Source/solver/Simulation.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Simulation.cpp -------------------------------------------------------------------------------- /Code/Source/solver/Simulation.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Simulation.h -------------------------------------------------------------------------------- /Code/Source/solver/SimulationLogger.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/SimulationLogger.h -------------------------------------------------------------------------------- /Code/Source/solver/Tensor4.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Tensor4.cpp -------------------------------------------------------------------------------- /Code/Source/solver/Tensor4.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Tensor4.h -------------------------------------------------------------------------------- /Code/Source/solver/Timer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Timer.h -------------------------------------------------------------------------------- /Code/Source/solver/TrilinosLinearAlgebra.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/TrilinosLinearAlgebra.cpp -------------------------------------------------------------------------------- /Code/Source/solver/TrilinosLinearAlgebra.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/TrilinosLinearAlgebra.h -------------------------------------------------------------------------------- /Code/Source/solver/Vector.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Vector.cpp -------------------------------------------------------------------------------- /Code/Source/solver/Vector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/Vector.h -------------------------------------------------------------------------------- /Code/Source/solver/VtkData.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/VtkData.cpp -------------------------------------------------------------------------------- /Code/Source/solver/VtkData.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/VtkData.h -------------------------------------------------------------------------------- /Code/Source/solver/all_fun.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/all_fun.cpp -------------------------------------------------------------------------------- /Code/Source/solver/all_fun.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/all_fun.h -------------------------------------------------------------------------------- /Code/Source/solver/baf_ini.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/baf_ini.cpp -------------------------------------------------------------------------------- /Code/Source/solver/baf_ini.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/baf_ini.h -------------------------------------------------------------------------------- /Code/Source/solver/bf.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/bf.cpp -------------------------------------------------------------------------------- /Code/Source/solver/bf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/bf.h -------------------------------------------------------------------------------- /Code/Source/solver/cep.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/cep.cpp -------------------------------------------------------------------------------- /Code/Source/solver/cep.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/cep.h -------------------------------------------------------------------------------- /Code/Source/solver/cep_ion.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/cep_ion.cpp -------------------------------------------------------------------------------- /Code/Source/solver/cep_ion.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/cep_ion.h -------------------------------------------------------------------------------- /Code/Source/solver/cmm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/cmm.cpp -------------------------------------------------------------------------------- /Code/Source/solver/cmm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/cmm.h -------------------------------------------------------------------------------- /Code/Source/solver/consts.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/consts.cpp -------------------------------------------------------------------------------- /Code/Source/solver/consts.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/consts.h -------------------------------------------------------------------------------- /Code/Source/solver/contact.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/contact.cpp -------------------------------------------------------------------------------- /Code/Source/solver/contact.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/contact.h -------------------------------------------------------------------------------- /Code/Source/solver/distribute.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/distribute.cpp -------------------------------------------------------------------------------- /Code/Source/solver/distribute.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/distribute.h -------------------------------------------------------------------------------- /Code/Source/solver/eq_assem.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/eq_assem.cpp -------------------------------------------------------------------------------- /Code/Source/solver/eq_assem.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/eq_assem.h -------------------------------------------------------------------------------- /Code/Source/solver/fft.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/fft.cpp -------------------------------------------------------------------------------- /Code/Source/solver/fft.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/fft.h -------------------------------------------------------------------------------- /Code/Source/solver/fluid.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/fluid.cpp -------------------------------------------------------------------------------- /Code/Source/solver/fluid.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/fluid.h -------------------------------------------------------------------------------- /Code/Source/solver/fs.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/fs.cpp -------------------------------------------------------------------------------- /Code/Source/solver/fs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/fs.h -------------------------------------------------------------------------------- /Code/Source/solver/fsi.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/fsi.cpp -------------------------------------------------------------------------------- /Code/Source/solver/fsi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/fsi.h -------------------------------------------------------------------------------- /Code/Source/solver/gmres.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/gmres.cpp -------------------------------------------------------------------------------- /Code/Source/solver/heatf.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/heatf.cpp -------------------------------------------------------------------------------- /Code/Source/solver/heatf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/heatf.h -------------------------------------------------------------------------------- /Code/Source/solver/heats.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/heats.cpp -------------------------------------------------------------------------------- /Code/Source/solver/heats.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/heats.h -------------------------------------------------------------------------------- /Code/Source/solver/initialize.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/initialize.cpp -------------------------------------------------------------------------------- /Code/Source/solver/initialize.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/initialize.h -------------------------------------------------------------------------------- /Code/Source/solver/interface.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/interface.cpp -------------------------------------------------------------------------------- /Code/Source/solver/l_elas.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/l_elas.cpp -------------------------------------------------------------------------------- /Code/Source/solver/l_elas.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/l_elas.h -------------------------------------------------------------------------------- /Code/Source/solver/lapack_defs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/lapack_defs.h -------------------------------------------------------------------------------- /Code/Source/solver/lhsa.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/lhsa.cpp -------------------------------------------------------------------------------- /Code/Source/solver/lhsa.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/lhsa.h -------------------------------------------------------------------------------- /Code/Source/solver/load_msh.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/load_msh.cpp -------------------------------------------------------------------------------- /Code/Source/solver/load_msh.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/load_msh.h -------------------------------------------------------------------------------- /Code/Source/solver/ls.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ls.cpp -------------------------------------------------------------------------------- /Code/Source/solver/ls.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ls.h -------------------------------------------------------------------------------- /Code/Source/solver/main.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/main.cpp -------------------------------------------------------------------------------- /Code/Source/solver/mat_fun.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/mat_fun.cpp -------------------------------------------------------------------------------- /Code/Source/solver/mat_fun.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/mat_fun.h -------------------------------------------------------------------------------- /Code/Source/solver/mat_models.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/mat_models.cpp -------------------------------------------------------------------------------- /Code/Source/solver/mat_models.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/mat_models.h -------------------------------------------------------------------------------- /Code/Source/solver/mesh.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/mesh.cpp -------------------------------------------------------------------------------- /Code/Source/solver/mesh.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/mesh.h -------------------------------------------------------------------------------- /Code/Source/solver/mueluOptions.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/mueluOptions.xml -------------------------------------------------------------------------------- /Code/Source/solver/nn.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/nn.cpp -------------------------------------------------------------------------------- /Code/Source/solver/nn.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/nn.h -------------------------------------------------------------------------------- /Code/Source/solver/nn_elem_gip.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/nn_elem_gip.h -------------------------------------------------------------------------------- /Code/Source/solver/nn_elem_gnn.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/nn_elem_gnn.h -------------------------------------------------------------------------------- /Code/Source/solver/nn_elem_gnnxx.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/nn_elem_gnnxx.h -------------------------------------------------------------------------------- /Code/Source/solver/nn_elem_nn_bnds.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/nn_elem_nn_bnds.h -------------------------------------------------------------------------------- /Code/Source/solver/nn_elem_props.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/nn_elem_props.h -------------------------------------------------------------------------------- /Code/Source/solver/output.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/output.cpp -------------------------------------------------------------------------------- /Code/Source/solver/output.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/output.h -------------------------------------------------------------------------------- /Code/Source/solver/petsc_impl.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/petsc_impl.cpp -------------------------------------------------------------------------------- /Code/Source/solver/petsc_impl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/petsc_impl.h -------------------------------------------------------------------------------- /Code/Source/solver/pic.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/pic.cpp -------------------------------------------------------------------------------- /Code/Source/solver/pic.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/pic.h -------------------------------------------------------------------------------- /Code/Source/solver/post.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/post.cpp -------------------------------------------------------------------------------- /Code/Source/solver/post.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/post.h -------------------------------------------------------------------------------- /Code/Source/solver/read_files.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/read_files.cpp -------------------------------------------------------------------------------- /Code/Source/solver/read_files.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/read_files.h -------------------------------------------------------------------------------- /Code/Source/solver/read_msh.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/read_msh.cpp -------------------------------------------------------------------------------- /Code/Source/solver/read_msh.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/read_msh.h -------------------------------------------------------------------------------- /Code/Source/solver/remesh.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/remesh.cpp -------------------------------------------------------------------------------- /Code/Source/solver/remesh.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/remesh.h -------------------------------------------------------------------------------- /Code/Source/solver/remeshTet.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/remeshTet.cpp -------------------------------------------------------------------------------- /Code/Source/solver/remeshTet.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/remeshTet.h -------------------------------------------------------------------------------- /Code/Source/solver/ris.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ris.cpp -------------------------------------------------------------------------------- /Code/Source/solver/ris.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ris.h -------------------------------------------------------------------------------- /Code/Source/solver/set_bc.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/set_bc.cpp -------------------------------------------------------------------------------- /Code/Source/solver/set_bc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/set_bc.h -------------------------------------------------------------------------------- /Code/Source/solver/set_equation_dof.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/set_equation_dof.h -------------------------------------------------------------------------------- /Code/Source/solver/set_equation_props.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/set_equation_props.h -------------------------------------------------------------------------------- /Code/Source/solver/set_material_props.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/set_material_props.h -------------------------------------------------------------------------------- /Code/Source/solver/set_output_props.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/set_output_props.h -------------------------------------------------------------------------------- /Code/Source/solver/set_viscosity_props.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/set_viscosity_props.h -------------------------------------------------------------------------------- /Code/Source/solver/shells.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/shells.cpp -------------------------------------------------------------------------------- /Code/Source/solver/shells.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/shells.h -------------------------------------------------------------------------------- /Code/Source/solver/stokes.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/stokes.cpp -------------------------------------------------------------------------------- /Code/Source/solver/stokes.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/stokes.h -------------------------------------------------------------------------------- /Code/Source/solver/svZeroD_interface/LPNSolverInterface.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/svZeroD_interface/LPNSolverInterface.cpp -------------------------------------------------------------------------------- /Code/Source/solver/svZeroD_interface/LPNSolverInterface.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/svZeroD_interface/LPNSolverInterface.h -------------------------------------------------------------------------------- /Code/Source/solver/svZeroD_subroutines.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/svZeroD_subroutines.cpp -------------------------------------------------------------------------------- /Code/Source/solver/svZeroD_subroutines.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/svZeroD_subroutines.h -------------------------------------------------------------------------------- /Code/Source/solver/sv_struct.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/sv_struct.cpp -------------------------------------------------------------------------------- /Code/Source/solver/sv_struct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/sv_struct.h -------------------------------------------------------------------------------- /Code/Source/solver/trilinos_impl.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/trilinos_impl.cpp -------------------------------------------------------------------------------- /Code/Source/solver/trilinos_impl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/trilinos_impl.h -------------------------------------------------------------------------------- /Code/Source/solver/txt.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/txt.cpp -------------------------------------------------------------------------------- /Code/Source/solver/txt.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/txt.h -------------------------------------------------------------------------------- /Code/Source/solver/uris.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/uris.cpp -------------------------------------------------------------------------------- /Code/Source/solver/uris.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/uris.h -------------------------------------------------------------------------------- /Code/Source/solver/ustruct.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ustruct.cpp -------------------------------------------------------------------------------- /Code/Source/solver/ustruct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/ustruct.h -------------------------------------------------------------------------------- /Code/Source/solver/utils.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/utils.cpp -------------------------------------------------------------------------------- /Code/Source/solver/utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/utils.h -------------------------------------------------------------------------------- /Code/Source/solver/vtk_xml.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/vtk_xml.cpp -------------------------------------------------------------------------------- /Code/Source/solver/vtk_xml.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/vtk_xml.h -------------------------------------------------------------------------------- /Code/Source/solver/vtk_xml_parser.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/vtk_xml_parser.cpp -------------------------------------------------------------------------------- /Code/Source/solver/vtk_xml_parser.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/Source/solver/vtk_xml_parser.h -------------------------------------------------------------------------------- /Code/ThirdParty/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/README.md -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/Cholesky: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/Cholesky -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/CholmodSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/CholmodSupport -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/Core: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/Core -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/Dense: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/Dense -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/Eigen: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/Eigen -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/Eigenvalues: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/Eigenvalues -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/Geometry: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/Geometry -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/Householder: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/Householder -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/Jacobi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/Jacobi -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/KLUSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/KLUSupport -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/LU: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/LU -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/MetisSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/MetisSupport -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/OrderingMethods: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/OrderingMethods -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/PaStiXSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/PaStiXSupport -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/PardisoSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/PardisoSupport -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/QR: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/QR -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/QtAlignedMalloc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/QtAlignedMalloc -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/SPQRSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/SPQRSupport -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/SVD: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/SVD -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/Sparse: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/Sparse -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/SparseCholesky: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/SparseCholesky -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/SparseCore: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/SparseCore -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/SparseLU: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/SparseLU -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/SparseQR: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/SparseQR -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/StdDeque: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/StdDeque -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/StdList: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/StdList -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/StdVector: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/StdVector -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/SuperLUSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/SuperLUSupport -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/UmfPackSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/UmfPackSupport -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Cholesky/LDLT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Cholesky/LDLT.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Cholesky/LLT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Cholesky/LLT.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Array.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Array.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/ArrayBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/ArrayBase.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Assign.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Assign.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Block.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Block.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/DenseBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/DenseBase.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Diagonal.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Diagonal.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Dot.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Dot.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/EigenBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/EigenBase.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Fuzzy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Fuzzy.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/IO.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/IO.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Inverse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Inverse.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Map.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Map.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/MapBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/MapBase.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Matrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Matrix.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/NoAlias.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/NoAlias.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/NumTraits.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/NumTraits.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Product.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Product.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Random.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Random.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Redux.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Redux.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Ref.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Ref.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Replicate.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Replicate.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Reshaped.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Reshaped.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Reverse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Reverse.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Select.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Select.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Solve.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Solve.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Stride.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Stride.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Swap.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Swap.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Transpose.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Transpose.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Visitor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/Visitor.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/util/Meta.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Core/util/Meta.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/Jacobi/Jacobi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/Jacobi/Jacobi.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/LU/Determinant.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/LU/Determinant.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/LU/FullPivLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/LU/FullPivLU.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/LU/InverseImpl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/LU/InverseImpl.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/SVD/BDCSVD.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/SVD/BDCSVD.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/SVD/JacobiSVD.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/SVD/JacobiSVD.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/SVD/SVDBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/SVD/SVDBase.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/Image.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/Image.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/Kernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/Kernel.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/blas.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/blas.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/lapack.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/lapack.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/lapacke.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/Eigen/src/misc/lapacke.h -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/AutoDiff: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/AutoDiff -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/BVH: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/BVH -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/FFT: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/FFT -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/Skyline: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/Skyline -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/Splines: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/include/eigen3/unsupported/Eigen/Splines -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/share/eigen3/cmake/Eigen3Config.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/share/eigen3/cmake/Eigen3Config.cmake -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/share/eigen3/cmake/Eigen3Targets.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/share/eigen3/cmake/Eigen3Targets.cmake -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/share/eigen3/cmake/UseEigen3.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/share/eigen3/cmake/UseEigen3.cmake -------------------------------------------------------------------------------- /Code/ThirdParty/eigen/share/pkgconfig/eigen3.pc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/eigen/share/pkgconfig/eigen3.pc -------------------------------------------------------------------------------- /Code/ThirdParty/gklib_internal/CMakeLists.txt: -------------------------------------------------------------------------------- 1 | simvascular_third_party(gklib_internal) 2 | -------------------------------------------------------------------------------- /Code/ThirdParty/gklib_internal/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/gklib_internal/README.md -------------------------------------------------------------------------------- /Code/ThirdParty/gklib_internal/simvascular_gklib_internal.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/gklib_internal/simvascular_gklib_internal.h.in -------------------------------------------------------------------------------- /Code/ThirdParty/gklib_internal/simvascular_gklib_internal/b64.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/gklib_internal/simvascular_gklib_internal/b64.c -------------------------------------------------------------------------------- /Code/ThirdParty/gklib_internal/simvascular_gklib_internal/csr.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/gklib_internal/simvascular_gklib_internal/csr.c -------------------------------------------------------------------------------- /Code/ThirdParty/gklib_internal/simvascular_gklib_internal/fs.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/gklib_internal/simvascular_gklib_internal/fs.c -------------------------------------------------------------------------------- /Code/ThirdParty/gklib_internal/simvascular_gklib_internal/io.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/gklib_internal/simvascular_gklib_internal/io.c -------------------------------------------------------------------------------- /Code/ThirdParty/gklib_internal/simvascular_gklib_internal/rw.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/gklib_internal/simvascular_gklib_internal/rw.c -------------------------------------------------------------------------------- /Code/ThirdParty/gklib_internal/simvascular_gklib_internal/seq.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/gklib_internal/simvascular_gklib_internal/seq.c -------------------------------------------------------------------------------- /Code/ThirdParty/metis_internal/CMakeLists.txt: -------------------------------------------------------------------------------- 1 | simvascular_third_party(metis_internal) 2 | -------------------------------------------------------------------------------- /Code/ThirdParty/metis_internal/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/metis_internal/README.md -------------------------------------------------------------------------------- /Code/ThirdParty/metis_internal/simvascular_metis_internal.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/metis_internal/simvascular_metis_internal.h.in -------------------------------------------------------------------------------- /Code/ThirdParty/metis_internal/simvascular_metis_internal/METISLib/.gitignore: -------------------------------------------------------------------------------- 1 | temp/ 2 | -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/mpi.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/mpi.f90 -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/mpi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/mpi.h -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/mpi.h.org: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/mpi.h.org -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/mpif.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/mpif.h -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/mpif.h.org: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/mpif.h.org -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/mpio.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/mpio.h -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/mspms.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/mspms.h -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/pmidbg.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/pmidbg.h -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/x64/mpifptr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/x64/mpifptr.h -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Include/x86/mpifptr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Include/x86/mpifptr.h -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/Installers/msmpisdk.msi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/Installers/msmpisdk.msi -------------------------------------------------------------------------------- /Code/ThirdParty/msmpi/License/license_sdk.rtf: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/msmpi/License/license_sdk.rtf -------------------------------------------------------------------------------- /Code/ThirdParty/parmetis_internal/CMakeLists.txt: -------------------------------------------------------------------------------- 1 | simvascular_third_party(parmetis_internal) 2 | -------------------------------------------------------------------------------- /Code/ThirdParty/parmetis_internal/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/parmetis_internal/README.md -------------------------------------------------------------------------------- /Code/ThirdParty/parmetis_internal/simvascular_parmetis_internal/ParMETISLib/temp/metis.h: -------------------------------------------------------------------------------- 1 | -------------------------------------------------------------------------------- /Code/ThirdParty/share/eigen3/cmake/Eigen3Config.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/share/eigen3/cmake/Eigen3Config.cmake -------------------------------------------------------------------------------- /Code/ThirdParty/share/eigen3/cmake/Eigen3ConfigVersion.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/share/eigen3/cmake/Eigen3ConfigVersion.cmake -------------------------------------------------------------------------------- /Code/ThirdParty/share/eigen3/cmake/Eigen3Targets.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/share/eigen3/cmake/Eigen3Targets.cmake -------------------------------------------------------------------------------- /Code/ThirdParty/share/eigen3/cmake/UseEigen3.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/share/eigen3/cmake/UseEigen3.cmake -------------------------------------------------------------------------------- /Code/ThirdParty/share/pkgconfig/eigen3.pc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/share/pkgconfig/eigen3.pc -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/CMakeLists.txt: -------------------------------------------------------------------------------- 1 | simvascular_third_party(tetgen) 2 | -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/Makefile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/Makefile -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen.h.in -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/CMakeLists.txt -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/LICENSE: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/LICENSE -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/Makefile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/Makefile -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/README: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/README -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/README.simvascular: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/README.simvascular -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/example.poly: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/example.poly -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/makefile.tetgen.org: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/makefile.tetgen.org -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/predicates.cxx: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/predicates.cxx -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/tetgen.cxx: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/tetgen.cxx -------------------------------------------------------------------------------- /Code/ThirdParty/tetgen/simvascular_tetgen/tetgen.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tetgen/simvascular_tetgen/tetgen.h -------------------------------------------------------------------------------- /Code/ThirdParty/tinyxml/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tinyxml/CMakeLists.txt -------------------------------------------------------------------------------- /Code/ThirdParty/tinyxml/simvascular_tinyxml.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tinyxml/simvascular_tinyxml.h.in -------------------------------------------------------------------------------- /Code/ThirdParty/tinyxml/simvascular_tinyxml/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tinyxml/simvascular_tinyxml/CMakeLists.txt -------------------------------------------------------------------------------- /Code/ThirdParty/tinyxml/simvascular_tinyxml/tinyxml2.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tinyxml/simvascular_tinyxml/tinyxml2.cpp -------------------------------------------------------------------------------- /Code/ThirdParty/tinyxml/simvascular_tinyxml/tinyxml2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Code/ThirdParty/tinyxml/simvascular_tinyxml/tinyxml2.h -------------------------------------------------------------------------------- /Distribution/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/CMakeLists.txt -------------------------------------------------------------------------------- /Distribution/OSX/Info.plist.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/OSX/Info.plist.in -------------------------------------------------------------------------------- /Distribution/OSX/cpmview.icns: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/OSX/cpmview.icns -------------------------------------------------------------------------------- /Distribution/OSX/simvascular.icns: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/OSX/simvascular.icns -------------------------------------------------------------------------------- /Distribution/OSX/simvascular.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/OSX/simvascular.sh -------------------------------------------------------------------------------- /Distribution/OSX/simvascular.sh.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/OSX/simvascular.sh.in -------------------------------------------------------------------------------- /Distribution/license.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/license.txt -------------------------------------------------------------------------------- /Distribution/windows/msi-banner.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/windows/msi-banner.bmp -------------------------------------------------------------------------------- /Distribution/windows/msi-banner.jpg: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/windows/msi-banner.jpg -------------------------------------------------------------------------------- /Distribution/windows/msi-dialog.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/windows/msi-dialog.bmp -------------------------------------------------------------------------------- /Distribution/windows/msi-dialog.jpg: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/windows/msi-dialog.jpg -------------------------------------------------------------------------------- /Distribution/windows/mywix.template-notargets.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/windows/mywix.template-notargets.in -------------------------------------------------------------------------------- /Distribution/windows/mywix.template.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/windows/mywix.template.in -------------------------------------------------------------------------------- /Distribution/windows/registry-patch-notargets.xml.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/windows/registry-patch-notargets.xml.in -------------------------------------------------------------------------------- /Distribution/windows/registry-patch.xml.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/windows/registry-patch.xml.in -------------------------------------------------------------------------------- /Distribution/windows/simvascular.ico: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Distribution/windows/simvascular.ico -------------------------------------------------------------------------------- /Docker/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Docker/README.md -------------------------------------------------------------------------------- /Docker/solver/dockerfile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Docker/solver/dockerfile -------------------------------------------------------------------------------- /Docker/ubuntu/dockerfile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Docker/ubuntu/dockerfile -------------------------------------------------------------------------------- /Documentation/Doxyfile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Documentation/Doxyfile -------------------------------------------------------------------------------- /Documentation/DoxygenLayout.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Documentation/DoxygenLayout.xml -------------------------------------------------------------------------------- /Documentation/doxygen-awesome.css: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Documentation/doxygen-awesome.css -------------------------------------------------------------------------------- /Documentation/internal.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Documentation/internal.md -------------------------------------------------------------------------------- /Documentation/references.bib: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Documentation/references.bib -------------------------------------------------------------------------------- /Externals/BuildHelpers/CompileScripts/tcl-linux-generic.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/CompileScripts/tcl-linux-generic.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/CompileScripts/tcl-mac_osx-generic.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/CompileScripts/tcl-mac_osx-generic.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/CompileScripts/tcl-mingw64-generic.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/CompileScripts/tcl-mingw64-generic.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/CompileScripts/tcl-osx-generic.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/CompileScripts/tcl-osx-generic.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/CompileScripts/tcl-windows-generic.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/CompileScripts/tcl-windows-generic.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/CygwinHelpers/clean-env.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/CygwinHelpers/clean-env.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/CygwinHelpers/msvc_2010_x64: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/CygwinHelpers/msvc_2010_x64 -------------------------------------------------------------------------------- /Externals/BuildHelpers/CygwinHelpers/msvc_2013_x64: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/CygwinHelpers/msvc_2013_x64 -------------------------------------------------------------------------------- /Externals/BuildHelpers/Patches/patch-source-tcltk-8.5.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Patches/patch-source-tcltk-8.5.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/Patches/patch-source-vtk-6.2.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Patches/patch-source-vtk-6.2.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/Patches/patch-source-vtk-6.3.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Patches/patch-source-vtk-6.3.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/Patches/tk-8.5.18-win-ttkWinXPTheme.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Patches/tk-8.5.18-win-ttkWinXPTheme.c -------------------------------------------------------------------------------- /Externals/BuildHelpers/Scripts/create-archives-generic.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Scripts/create-archives-generic.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/Scripts/superbuild-linux-gcc.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Scripts/superbuild-linux-gcc.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/Scripts/superbuild-mac_osx-clang.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Scripts/superbuild-mac_osx-clang.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/Scripts/superbuild-windows-cl.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Scripts/superbuild-windows-cl.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/Scripts/tar-to-zip-all.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Scripts/tar-to-zip-all.sh -------------------------------------------------------------------------------- /Externals/BuildHelpers/Scripts/untar-unzip-source-all.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/BuildHelpers/Scripts/untar-unzip-source-all.sh -------------------------------------------------------------------------------- /Externals/CMakeExternals/SvExtOptions.cmake: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/CMakeExternals/SvExtOptions.cmake -------------------------------------------------------------------------------- /Externals/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/CMakeLists.txt -------------------------------------------------------------------------------- /Externals/build-sv-externals-helper-wget-generic.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/build-sv-externals-helper-wget-generic.sh -------------------------------------------------------------------------------- /Externals/build-sv-externals-linux.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/build-sv-externals-linux.sh -------------------------------------------------------------------------------- /Externals/build-sv-externals-mac_osx.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/build-sv-externals-mac_osx.sh -------------------------------------------------------------------------------- /Externals/build-sv-externals-windows.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Externals/build-sv-externals-windows.sh -------------------------------------------------------------------------------- /LICENSE.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/LICENSE.txt -------------------------------------------------------------------------------- /Licenses/LesLib/README-LESLIB.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/Licenses/LesLib/README-LESLIB.txt -------------------------------------------------------------------------------- /README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/README.md -------------------------------------------------------------------------------- /tests/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/README.md -------------------------------------------------------------------------------- /tests/__init__.py: -------------------------------------------------------------------------------- 1 | -------------------------------------------------------------------------------- /tests/cases/cep/cable_TTP_1d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/cable_TTP_1d/README.md -------------------------------------------------------------------------------- /tests/cases/cep/cable_TTP_1d/mesh/.gitattributes: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/cable_TTP_1d/mesh/.gitattributes -------------------------------------------------------------------------------- /tests/cases/cep/cable_TTP_1d/mesh/bar_h0.40.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/cable_TTP_1d/mesh/bar_h0.40.vtu -------------------------------------------------------------------------------- /tests/cases/cep/cable_TTP_1d/mesh/domain_info_h0.40.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/cable_TTP_1d/mesh/domain_info_h0.40.dat -------------------------------------------------------------------------------- /tests/cases/cep/cable_TTP_1d/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/cable_TTP_1d/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/cep/cable_TTP_1d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/cable_TTP_1d/solver.xml -------------------------------------------------------------------------------- /tests/cases/cep/purkinje/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/purkinje/README.md -------------------------------------------------------------------------------- /tests/cases/cep/purkinje/activation_10fps.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/purkinje/activation_10fps.gif -------------------------------------------------------------------------------- /tests/cases/cep/purkinje/mesh/domain_pfib_LV.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/purkinje/mesh/domain_pfib_LV.dat -------------------------------------------------------------------------------- /tests/cases/cep/purkinje/mesh/domain_pfib_RV.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/purkinje/mesh/domain_pfib_RV.dat -------------------------------------------------------------------------------- /tests/cases/cep/purkinje/mesh/pfib_LV.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/purkinje/mesh/pfib_LV.vtu -------------------------------------------------------------------------------- /tests/cases/cep/purkinje/mesh/pfib_RV.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/purkinje/mesh/pfib_RV.vtu -------------------------------------------------------------------------------- /tests/cases/cep/purkinje/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/purkinje/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/cep/purkinje/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/purkinje/solver.xml -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/BO_S1S2_spiral_Ts470.0300.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/BO_S1S2_spiral_Ts470.0300.png -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/README.md -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/mesh/mesh-surfaces/X0.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/mesh/mesh-surfaces/X0.vtp -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/mesh/mesh-surfaces/X1.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/mesh/mesh-surfaces/X1.vtp -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/mesh/mesh-surfaces/Y0.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/mesh/mesh-surfaces/Y0.vtp -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/mesh/mesh-surfaces/Y1.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/mesh/mesh-surfaces/Y1.vtp -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/mesh/spiral_domain_info.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/mesh/spiral_domain_info.dat -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/cep/spiral_BO_2d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/spiral_BO_2d/solver.xml -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/README.md -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/mesh/domain_info.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/mesh/domain_info.dat -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/mesh/mesh-surfaces/bottom.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/mesh/mesh-surfaces/bottom.vtp -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/mesh/mesh-surfaces/left.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/mesh/mesh-surfaces/left.vtp -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/mesh/mesh-surfaces/right.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/mesh/mesh-surfaces/right.vtp -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/mesh/mesh-surfaces/top.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/mesh/mesh-surfaces/top.vtp -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/mesh/spiral_domain_info.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/mesh/spiral_domain_info.dat -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/cep/square_AP_2d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cep/square_AP_2d/solver.xml -------------------------------------------------------------------------------- /tests/cases/cmm/iliac_artery_variable_wall_props/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/iliac_artery_variable_wall_props/README.md -------------------------------------------------------------------------------- /tests/cases/cmm/iliac_artery_variable_wall_props/bct.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/iliac_artery_variable_wall_props/bct.vtp -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/1-rigid-solution/calcMeanPressTrac.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/1-rigid-solution/calcMeanPressTrac.py -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/1-rigid-solution/result_800.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/1-rigid-solution/result_800.vtu -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/1-rigid-solution/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/1-rigid-solution/solver.xml -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/2a-inflate/result_003.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/2a-inflate/result_003.vtu -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/2a-inflate/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/2a-inflate/solver.xml -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/2b-prestress/result_003.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/2b-prestress/result_003.vtu -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/2b-prestress/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/2b-prestress/solver.xml -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/3a-inflate-cmm/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/3a-inflate-cmm/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/3a-inflate-cmm/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/3a-inflate-cmm/solver.xml -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/3b-prestress-cmm/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/3b-prestress-cmm/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/3b-prestress-cmm/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/3b-prestress-cmm/solver.xml -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/README.md -------------------------------------------------------------------------------- /tests/cases/cmm/pipe_3d/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/cmm/pipe_3d/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/carreau_yasuda/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/carreau_yasuda/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/carreau_yasuda/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/carreau_yasuda/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/carreau_yasuda/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/carreau_yasuda/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/carreau_yasuda/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/carreau_yasuda/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/carreau_yasuda/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/carreau_yasuda/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/casson/Compare_nonNewtonian_models.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/Compare_nonNewtonian_models.png -------------------------------------------------------------------------------- /tests/cases/fluid/casson/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/casson/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/casson/mesh/mesh-complete.exterior.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/mesh/mesh-complete.exterior.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/casson/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/casson/mesh/mesh-surfaces/lumen_inlet.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/mesh/mesh-surfaces/lumen_inlet.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/casson/mesh/mesh-surfaces/lumen_outlet.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/mesh/mesh-surfaces/lumen_outlet.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/casson/mesh/mesh-surfaces/lumen_wall.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/mesh/mesh-surfaces/lumen_wall.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/casson/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/casson/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/casson/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/driven_cavity_2d/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/driven_cavity_2d/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/driven_cavity_2d/mesh/mesh-surfaces/left.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/driven_cavity_2d/mesh/mesh-surfaces/left.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/driven_cavity_2d/mesh/mesh-surfaces/right.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/driven_cavity_2d/mesh/mesh-surfaces/right.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/driven_cavity_2d/mesh/mesh-surfaces/top.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/driven_cavity_2d/mesh/mesh-surfaces/top.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/driven_cavity_2d/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/driven_cavity_2d/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/driven_cavity_2d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/driven_cavity_2d/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/driven_cavity_2d_porous/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/driven_cavity_2d_porous/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/driven_cavity_2d_porous/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/driven_cavity_2d_porous/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/dye_AD/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/dye_AD/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/dye_AD/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/dye_AD/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/dye_AD/mesh/mesh-complete.exterior.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/dye_AD/mesh/mesh-complete.exterior.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/dye_AD/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/dye_AD/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/dye_AD/mesh/mesh-surfaces/lumen_inlet.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/dye_AD/mesh/mesh-surfaces/lumen_inlet.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/dye_AD/mesh/mesh-surfaces/lumen_outlet.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/dye_AD/mesh/mesh-surfaces/lumen_outlet.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/dye_AD/mesh/mesh-surfaces/lumen_wall.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/dye_AD/mesh/mesh-surfaces/lumen_wall.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/dye_AD/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/dye_AD/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/dye_AD/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/dye_AD/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/iliac_artery/mesh/mesh-complete.exterior.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/iliac_artery/mesh/mesh-complete.exterior.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/iliac_artery/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/iliac_artery/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/iliac_artery/mesh/mesh-surfaces/cap_aorta.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/iliac_artery/mesh/mesh-surfaces/cap_aorta.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/iliac_artery/mesh/walls_combined.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/iliac_artery/mesh/walls_combined.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/iliac_artery/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/iliac_artery/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/iliac_artery/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/iliac_artery/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/iliac_artery_trilinos_gmres_ilut/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/iliac_artery_trilinos_gmres_ilut/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/newtonian/Compare_nonNewtonian_models.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/newtonian/Compare_nonNewtonian_models.png -------------------------------------------------------------------------------- /tests/cases/fluid/newtonian/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/newtonian/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/newtonian/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/newtonian/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/newtonian/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/newtonian/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/newtonian/mesh/mesh-surfaces/lumen_inlet.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/newtonian/mesh/mesh-surfaces/lumen_inlet.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/newtonian/mesh/mesh-surfaces/lumen_outlet.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/newtonian/mesh/mesh-surfaces/lumen_outlet.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/newtonian/mesh/mesh-surfaces/lumen_wall.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/newtonian/mesh/mesh-surfaces/lumen_wall.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/newtonian/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/newtonian/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/newtonian/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/newtonian/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d/mesh/mesh-surfaces/lumen_wall.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d/mesh/mesh-surfaces/lumen_wall.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_fourier_coeff/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_fourier_coeff/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_fourier_coeff/lumen_inlet.fcs: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_fourier_coeff/lumen_inlet.fcs -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_fourier_coeff/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_fourier_coeff/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_fourier_coeff/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_fourier_coeff/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_fourier_coeff/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_fourier_coeff/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_petsc/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_petsc/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_petsc/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_petsc/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_petsc/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_petsc/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_petsc/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_petsc/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_petsc/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_petsc/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_trilinos_bj/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_trilinos_bj/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_trilinos_bj/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_trilinos_bj/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_trilinos_bj/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_trilinos_bj/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_trilinos_bj/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_trilinos_bj/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_trilinos_ilut/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_trilinos_ilut/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_trilinos_ilut/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_trilinos_ilut/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_trilinos_ilut/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_trilinos_ilut/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_3d_trilinos_ilut/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_3d_trilinos_ilut/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/genBC/Makefile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/genBC/Makefile -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/genBC/Makefile.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/genBC/Makefile.in -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/genBC/src/GenBC.f: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/genBC/src/GenBC.f -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/genBC/src/Modules.f: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/genBC/src/Modules.f -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/genBC/src/USER.f: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/genBC/src/USER.f -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/lumen_inlet.flw: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/lumen_inlet.flw -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_genBC/validate_analytical.ipynb: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_genBC/validate_analytical.ipynb -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_sv0D/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_sv0D/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_sv0D/lumen_inlet.flw: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_sv0D/lumen_inlet.flw -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_sv0D/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_sv0D/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_sv0D/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_sv0D/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_sv0D/svzerod_3Dcoupling.json: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_sv0D/svzerod_3Dcoupling.json -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_sv0D/validate_analytical.ipynb: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_sv0D/validate_analytical.ipynb -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_weak_dir_3d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_weak_dir_3d/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_weak_dir_3d/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_weak_dir_3d/lumen_inlet.flow -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_weak_dir_3d/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_weak_dir_3d/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/pipe_RCR_weak_dir_3d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/pipe_RCR_weak_dir_3d/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/precomputed_dye_AD/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/precomputed_dye_AD/README.md -------------------------------------------------------------------------------- /tests/cases/fluid/precomputed_dye_AD/mesh/walls_combined.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/precomputed_dye_AD/mesh/walls_combined.vtp -------------------------------------------------------------------------------- /tests/cases/fluid/precomputed_dye_AD/precomputed_velocity.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/precomputed_dye_AD/precomputed_velocity.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/precomputed_dye_AD/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/precomputed_dye_AD/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/precomputed_dye_AD/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/precomputed_dye_AD/solver.xml -------------------------------------------------------------------------------- /tests/cases/fluid/quadratic_tet10/result_003.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/quadratic_tet10/result_003.vtu -------------------------------------------------------------------------------- /tests/cases/fluid/quadratic_tet10/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fluid/quadratic_tet10/solver.xml -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/README.md -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/configuration.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/configuration.png -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/mesh/fluid/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/mesh/fluid/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/mesh/fluid/mesh-surfaces/end.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/mesh/fluid/mesh-surfaces/end.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/mesh/fluid/mesh-surfaces/interface.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/mesh/fluid/mesh-surfaces/interface.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/mesh/fluid/mesh-surfaces/start.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/mesh/fluid/mesh-surfaces/start.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/mesh/solid/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/mesh/solid/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/mesh/solid/mesh-surfaces/end.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/mesh/solid/mesh-surfaces/end.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/mesh/solid/mesh-surfaces/interface.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/mesh/solid/mesh-surfaces/interface.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/mesh/solid/mesh-surfaces/outside.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/mesh/solid/mesh-surfaces/outside.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/mesh/solid/mesh-surfaces/start.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/mesh/solid/mesh-surfaces/start.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/results.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/results.gif -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d/solver.xml -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_petsc/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_petsc/README.md -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_petsc/configuration.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_petsc/configuration.png -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_petsc/mesh/fluid/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_petsc/mesh/fluid/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_petsc/mesh/fluid/mesh-surfaces/end.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_petsc/mesh/fluid/mesh-surfaces/end.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_petsc/mesh/solid/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_petsc/mesh/solid/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_petsc/mesh/solid/mesh-surfaces/end.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_petsc/mesh/solid/mesh-surfaces/end.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_petsc/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_petsc/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_petsc/results.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_petsc/results.gif -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_petsc/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_petsc/solver.xml -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_bj/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_bj/README.md -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_bj/configuration.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_bj/configuration.png -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_bj/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_bj/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_bj/results.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_bj/results.gif -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_bj/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_bj/solver.xml -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_ml/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_ml/README.md -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_ml/configuration.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_ml/configuration.png -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_ml/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_ml/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_ml/results.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_ml/results.gif -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_3d_trilinos_ml/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_3d_trilinos_ml/solver.xml -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_RCR_3d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_RCR_3d/README.md -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_RCR_3d/mesh/fluid/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_RCR_3d/mesh/fluid/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_RCR_3d/mesh/fluid/mesh-surfaces/end.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_RCR_3d/mesh/fluid/mesh-surfaces/end.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_RCR_3d/mesh/fluid/mesh-surfaces/start.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_RCR_3d/mesh/fluid/mesh-surfaces/start.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_RCR_3d/mesh/solid/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_RCR_3d/mesh/solid/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_RCR_3d/mesh/solid/mesh-surfaces/end.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_RCR_3d/mesh/solid/mesh-surfaces/end.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_RCR_3d/mesh/solid/mesh-surfaces/start.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_RCR_3d/mesh/solid/mesh-surfaces/start.vtp -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_RCR_3d/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_RCR_3d/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/fsi/pipe_RCR_3d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi/pipe_RCR_3d/solver.xml -------------------------------------------------------------------------------- /tests/cases/fsi_ustruct/pipe_3d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi_ustruct/pipe_3d/README.md -------------------------------------------------------------------------------- /tests/cases/fsi_ustruct/pipe_3d/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi_ustruct/pipe_3d/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/fsi_ustruct/pipe_3d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi_ustruct/pipe_3d/solver.xml -------------------------------------------------------------------------------- /tests/cases/fsi_ustruct/pipe_RCR_3d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi_ustruct/pipe_RCR_3d/README.md -------------------------------------------------------------------------------- /tests/cases/fsi_ustruct/pipe_RCR_3d/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi_ustruct/pipe_RCR_3d/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/fsi_ustruct/pipe_RCR_3d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/fsi_ustruct/pipe_RCR_3d/solver.xml -------------------------------------------------------------------------------- /tests/cases/heats/diffusion_line_source/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/heats/diffusion_line_source/README.md -------------------------------------------------------------------------------- /tests/cases/heats/diffusion_line_source/bc_left.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/heats/diffusion_line_source/bc_left.dat -------------------------------------------------------------------------------- /tests/cases/heats/diffusion_line_source/plot-temp-flux.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/heats/diffusion_line_source/plot-temp-flux.png -------------------------------------------------------------------------------- /tests/cases/heats/diffusion_line_source/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/heats/diffusion_line_source/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/heats/diffusion_line_source/solver_BICG.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/heats/diffusion_line_source/solver_BICG.xml -------------------------------------------------------------------------------- /tests/cases/heats/diffusion_line_source/solver_CG.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/heats/diffusion_line_source/solver_CG.xml -------------------------------------------------------------------------------- /tests/cases/heats/diffusion_line_source/solver_GMRES.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/heats/diffusion_line_source/solver_GMRES.xml -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/README.md -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/load.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/load.dat -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/back.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/back.vtp -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/front.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/front.vtp -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/left.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/left.vtp -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/right.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/right.vtp -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/top.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/mesh/mesh-surfaces/top.vtp -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/linear-elasticity/beam/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/linear-elasticity/beam/solver.xml -------------------------------------------------------------------------------- /tests/cases/ris/pipe_ris_3d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ris/pipe_ris_3d/README.md -------------------------------------------------------------------------------- /tests/cases/ris/pipe_ris_3d/inlet.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ris/pipe_ris_3d/inlet.dat -------------------------------------------------------------------------------- /tests/cases/ris/pipe_ris_3d/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ris/pipe_ris_3d/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/ris/pipe_ris_3d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ris/pipe_ris_3d/solver.xml -------------------------------------------------------------------------------- /tests/cases/shell/plate/mesh/2Dsqr_NURBS_C1.msh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/plate/mesh/2Dsqr_NURBS_C1.msh -------------------------------------------------------------------------------- /tests/cases/shell/plate/mesh/tri3/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/plate/mesh/tri3/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/shell/plate/mesh/tri3/mesh-surfaces/x0.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/plate/mesh/tri3/mesh-surfaces/x0.vtp -------------------------------------------------------------------------------- /tests/cases/shell/plate/mesh/tri3/mesh-surfaces/x1.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/plate/mesh/tri3/mesh-surfaces/x1.vtp -------------------------------------------------------------------------------- /tests/cases/shell/plate/mesh/tri3/mesh-surfaces/y0.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/plate/mesh/tri3/mesh-surfaces/y0.vtp -------------------------------------------------------------------------------- /tests/cases/shell/plate/mesh/tri3/mesh-surfaces/y1.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/plate/mesh/tri3/mesh-surfaces/y1.vtp -------------------------------------------------------------------------------- /tests/cases/shell/plate/result_010.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/plate/result_010.vtu -------------------------------------------------------------------------------- /tests/cases/shell/plate/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/plate/solver.xml -------------------------------------------------------------------------------- /tests/cases/shell/valve/leaflet_deform_20fps.avi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/valve/leaflet_deform_20fps.avi -------------------------------------------------------------------------------- /tests/cases/shell/valve/mesh/PAT003_07_LCC.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/valve/mesh/PAT003_07_LCC.vtu -------------------------------------------------------------------------------- /tests/cases/shell/valve/mesh/PAT003_07_NCC.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/valve/mesh/PAT003_07_NCC.vtu -------------------------------------------------------------------------------- /tests/cases/shell/valve/mesh/PAT003_07_RCC.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/valve/mesh/PAT003_07_RCC.vtu -------------------------------------------------------------------------------- /tests/cases/shell/valve/pbc.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/valve/pbc.dat -------------------------------------------------------------------------------- /tests/cases/shell/valve/pbc_t.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/valve/pbc_t.png -------------------------------------------------------------------------------- /tests/cases/shell/valve/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/valve/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/shell/valve/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/shell/valve/solver.xml -------------------------------------------------------------------------------- /tests/cases/stokes/manufactured_solution/P1P1/N004/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/stokes/manufactured_solution/P1P1/N004/solver.xml -------------------------------------------------------------------------------- /tests/cases/stokes/manufactured_solution/P1P1/N008/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/stokes/manufactured_solution/P1P1/N008/solver.xml -------------------------------------------------------------------------------- /tests/cases/stokes/manufactured_solution/P1P1/N016/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/stokes/manufactured_solution/P1P1/N016/solver.xml -------------------------------------------------------------------------------- /tests/cases/stokes/manufactured_solution/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/stokes/manufactured_solution/README.md -------------------------------------------------------------------------------- /tests/cases/struct/LV_CANN_artery_material_model/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_CANN_artery_material_model/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/LV_Guccione_passive/load.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_Guccione_passive/load.dat -------------------------------------------------------------------------------- /tests/cases/struct/LV_Guccione_passive/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_Guccione_passive/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/struct/LV_Guccione_passive/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_Guccione_passive/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_active/LV_stress.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_active/LV_stress.dat -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_active/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_active/README.md -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_active/figures.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_active/figures.py -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_active/p-v_loop.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_active/p-v_loop.png -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_active/pressure.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_active/pressure.dat -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_active/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_active/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_active/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_active/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_passive/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_passive/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_passive/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_passive/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_passive_CANN/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_passive_CANN/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/LV_HolzapfelOgden_passive_k0/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_HolzapfelOgden_passive_k0/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive/README.md -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive/endo_pressure.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive/endo_pressure.dat -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive_genBC/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive_genBC/README.md -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive_genBC/pv_plot.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive_genBC/pv_plot.png -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive_genBC/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive_genBC/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive_sv0D/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive_sv0D/README.md -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive_sv0D/result_003.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive_sv0D/result_003.vtu -------------------------------------------------------------------------------- /tests/cases/struct/LV_NeoHookean_passive_sv0D/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/LV_NeoHookean_passive_sv0D/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/block_compression/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/block_compression/README.md -------------------------------------------------------------------------------- /tests/cases/struct/block_compression/load.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/block_compression/load.dat -------------------------------------------------------------------------------- /tests/cases/struct/block_compression/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/block_compression/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/struct/block_compression/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/block_compression/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/block_compression_CANN/load.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/block_compression_CANN/load.dat -------------------------------------------------------------------------------- /tests/cases/struct/block_compression_CANN/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/block_compression_CANN/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/struct/block_compression_CANN/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/block_compression_CANN/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/robin/mesh/mesh-complete.mesh.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/robin/mesh/mesh-complete.mesh.vtu -------------------------------------------------------------------------------- /tests/cases/struct/robin/mesh/mesh-surfaces/end.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/robin/mesh/mesh-surfaces/end.vtp -------------------------------------------------------------------------------- /tests/cases/struct/robin/mesh/mesh-surfaces/interface.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/robin/mesh/mesh-surfaces/interface.vtp -------------------------------------------------------------------------------- /tests/cases/struct/robin/mesh/mesh-surfaces/outside.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/robin/mesh/mesh-surfaces/outside.vtp -------------------------------------------------------------------------------- /tests/cases/struct/robin/mesh/mesh-surfaces/start.vtp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/robin/mesh/mesh-surfaces/start.vtp -------------------------------------------------------------------------------- /tests/cases/struct/robin/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/robin/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/struct/robin/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/robin/solver.xml -------------------------------------------------------------------------------- /tests/cases/struct/spatially_variable_robin/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/spatially_variable_robin/README.md -------------------------------------------------------------------------------- /tests/cases/struct/spatially_variable_robin/animation.avi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/spatially_variable_robin/animation.avi -------------------------------------------------------------------------------- /tests/cases/struct/spatially_variable_robin/animation.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/spatially_variable_robin/animation.gif -------------------------------------------------------------------------------- /tests/cases/struct/spatially_variable_robin/load.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/spatially_variable_robin/load.dat -------------------------------------------------------------------------------- /tests/cases/struct/spatially_variable_robin/load.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/spatially_variable_robin/load.png -------------------------------------------------------------------------------- /tests/cases/struct/spatially_variable_robin/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/spatially_variable_robin/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/struct/spatially_variable_robin/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/struct/spatially_variable_robin/solver.xml -------------------------------------------------------------------------------- /tests/cases/uris/pipe_uris_3d/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/uris/pipe_uris_3d/README.md -------------------------------------------------------------------------------- /tests/cases/uris/pipe_uris_3d/meshes/normal.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/uris/pipe_uris_3d/meshes/normal.dat -------------------------------------------------------------------------------- /tests/cases/uris/pipe_uris_3d/result_005.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/uris/pipe_uris_3d/result_005.vtu -------------------------------------------------------------------------------- /tests/cases/uris/pipe_uris_3d/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/uris/pipe_uris_3d/solver.xml -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_Guccione_active/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_Guccione_active/README.md -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_Guccione_active/animation.avi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_Guccione_active/animation.avi -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_Guccione_active/animation.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_Guccione_active/animation.gif -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_Guccione_active/fib_stress.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_Guccione_active/fib_stress.dat -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_Guccione_active/load.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_Guccione_active/load.dat -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_Guccione_active/mesh/P1/calcfiber.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_Guccione_active/mesh/P1/calcfiber.py -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_Guccione_active/mesh/P1/phi.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_Guccione_active/mesh/P1/phi.vtu -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_Guccione_active/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_Guccione_active/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_Guccione_active/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_Guccione_active/solver.xml -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_HolzapfelOgden_active/LV_stress.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_HolzapfelOgden_active/LV_stress.dat -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_HolzapfelOgden_active/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_HolzapfelOgden_active/README.md -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_HolzapfelOgden_active/figures.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_HolzapfelOgden_active/figures.py -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_HolzapfelOgden_active/p-v_loop.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_HolzapfelOgden_active/p-v_loop.png -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_HolzapfelOgden_active/pressure.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_HolzapfelOgden_active/pressure.dat -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_HolzapfelOgden_active/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_HolzapfelOgden_active/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_HolzapfelOgden_active/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_HolzapfelOgden_active/solver.xml -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_HolzapfelOgden_passive/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_HolzapfelOgden_passive/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_HolzapfelOgden_passive/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_HolzapfelOgden_passive/solver.xml -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_NeoHookean_passive_genBC/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_NeoHookean_passive_genBC/README.md -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_NeoHookean_passive_genBC/pv_plot.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_NeoHookean_passive_genBC/pv_plot.png -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_NeoHookean_passive_genBC/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_NeoHookean_passive_genBC/solver.xml -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_NeoHookean_passive_sv0D/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_NeoHookean_passive_sv0D/README.md -------------------------------------------------------------------------------- /tests/cases/ustruct/LV_NeoHookean_passive_sv0D/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/LV_NeoHookean_passive_sv0D/solver.xml -------------------------------------------------------------------------------- /tests/cases/ustruct/block_compression/P1P1_VMS/load.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/block_compression/P1P1_VMS/load.dat -------------------------------------------------------------------------------- /tests/cases/ustruct/block_compression/P1P1_VMS/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/block_compression/P1P1_VMS/solver.xml -------------------------------------------------------------------------------- /tests/cases/ustruct/spatially_variable_robin/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/spatially_variable_robin/README.md -------------------------------------------------------------------------------- /tests/cases/ustruct/spatially_variable_robin/animation.avi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/spatially_variable_robin/animation.avi -------------------------------------------------------------------------------- /tests/cases/ustruct/spatially_variable_robin/animation.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/spatially_variable_robin/animation.gif -------------------------------------------------------------------------------- /tests/cases/ustruct/spatially_variable_robin/load.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/spatially_variable_robin/load.dat -------------------------------------------------------------------------------- /tests/cases/ustruct/spatially_variable_robin/load.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/spatially_variable_robin/load.png -------------------------------------------------------------------------------- /tests/cases/ustruct/spatially_variable_robin/result_002.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/spatially_variable_robin/result_002.vtu -------------------------------------------------------------------------------- /tests/cases/ustruct/spatially_variable_robin/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/spatially_variable_robin/solver.xml -------------------------------------------------------------------------------- /tests/cases/ustruct/tensile_adventitia_HGO/load.dat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/tensile_adventitia_HGO/load.dat -------------------------------------------------------------------------------- /tests/cases/ustruct/tensile_adventitia_HGO/result_001.vtu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/tensile_adventitia_HGO/result_001.vtu -------------------------------------------------------------------------------- /tests/cases/ustruct/tensile_adventitia_HGO/solver.xml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/cases/ustruct/tensile_adventitia_HGO/solver.xml -------------------------------------------------------------------------------- /tests/conftest.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/conftest.py -------------------------------------------------------------------------------- /tests/test_cep.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_cep.py -------------------------------------------------------------------------------- /tests/test_cmm.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_cmm.py -------------------------------------------------------------------------------- /tests/test_fluid.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_fluid.py -------------------------------------------------------------------------------- /tests/test_fsi.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_fsi.py -------------------------------------------------------------------------------- /tests/test_fsi_ustruct.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_fsi_ustruct.py -------------------------------------------------------------------------------- /tests/test_heats.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_heats.py -------------------------------------------------------------------------------- /tests/test_linear_elasticity.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_linear_elasticity.py -------------------------------------------------------------------------------- /tests/test_ris.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_ris.py -------------------------------------------------------------------------------- /tests/test_shell.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_shell.py -------------------------------------------------------------------------------- /tests/test_stokes.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_stokes.py -------------------------------------------------------------------------------- /tests/test_struct.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_struct.py -------------------------------------------------------------------------------- /tests/test_uris.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_uris.py -------------------------------------------------------------------------------- /tests/test_ustruct.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/test_ustruct.py -------------------------------------------------------------------------------- /tests/unitTests/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/unitTests/README.md -------------------------------------------------------------------------------- /tests/unitTests/material_model_tests/test_material_common.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/unitTests/material_model_tests/test_material_common.h -------------------------------------------------------------------------------- /tests/unitTests/math_tests/test_fft.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/unitTests/math_tests/test_fft.cpp -------------------------------------------------------------------------------- /tests/unitTests/math_tests/test_fft.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/unitTests/math_tests/test_fft.h -------------------------------------------------------------------------------- /tests/unitTests/test_common.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/tests/unitTests/test_common.h -------------------------------------------------------------------------------- /utilities/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/utilities/README.md -------------------------------------------------------------------------------- /utilities/fourier_coefficients/README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/utilities/fourier_coefficients/README.md -------------------------------------------------------------------------------- /utilities/fourier_coefficients/fft_reconstruction.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/utilities/fourier_coefficients/fft_reconstruction.png -------------------------------------------------------------------------------- /utilities/fourier_coefficients/fft_temporal_values.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/utilities/fourier_coefficients/fft_temporal_values.py -------------------------------------------------------------------------------- /utilities/fourier_coefficients/lumen_inlet.fcs: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/utilities/fourier_coefficients/lumen_inlet.fcs -------------------------------------------------------------------------------- /utilities/fourier_coefficients/lumen_inlet.flow: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/utilities/fourier_coefficients/lumen_inlet.flow -------------------------------------------------------------------------------- /utilities/fourier_coefficients/requirements.txt: -------------------------------------------------------------------------------- 1 | matplotlib==3.10.3 2 | numpy==2.2.5 3 | -------------------------------------------------------------------------------- /utilities/generate_boundary_condition_data/generate_load.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/SimVascular/svMultiPhysics/HEAD/utilities/generate_boundary_condition_data/generate_load.py --------------------------------------------------------------------------------