├── .gitignore ├── README.md ├── latex ├── NGammaTiTe.pdf └── NGammaTiTe.tex ├── lib ├── Make.inc │ ├── arch.make │ ├── arch.make_marconi │ └── arch.make_meso └── Makefile ├── matlab ├── MHD_HDG_isotherm │ ├── BackgroundMesh.sub │ ├── Convergence.m │ ├── Convergence_p.m │ ├── FindCoefficients.m │ ├── Goldston_New.m │ ├── Goldstone_Postprocess.m │ ├── Goldstone_Postprocess_Curvature.m │ ├── HDF5load.m │ ├── HDG │ │ ├── GetFaces.m │ │ ├── calculateElementByElementSolution.m │ │ ├── calculateElementByElementSolutionProjection_second.m~ │ │ ├── calculateElementByElementVelocityGradient.m │ │ ├── computeElementByElementGradient3d.m │ │ ├── computeElementByElementSolution3d.m │ │ ├── hdg_AddDiffForLimitingRho.m │ │ ├── hdg_Assembly.m │ │ ├── hdg_Assembly3d.m │ │ ├── hdg_AssemblyProjection_first.m~ │ │ ├── hdg_AssemblyProjection_second.m~ │ │ ├── hdg_ConvectionMatrices.m │ │ ├── hdg_ConvectionMatrices_3D.m │ │ ├── hdg_ConvectionMatrices_NEW.m~ │ │ ├── hdg_ConvectionMatrices_newBC.m~ │ │ ├── hdg_ConvectionMatrices_noVec.m~ │ │ ├── hdg_IterativeSolver.asv │ │ ├── hdg_IterativeSolver.m │ │ ├── hdg_IterativeSolver.m~ │ │ ├── hdg_LocalDiffusionInPoints.m │ │ ├── hdg_Mapping.m │ │ ├── hdg_Mapping3d.m │ │ ├── hdg_MappingPrecond.m~ │ │ ├── hdg_MappingProject.m │ │ ├── hdg_MappingProject.m~ │ │ ├── hdg_MappingProjection_first.m~ │ │ ├── hdg_MappingProjection_second.m~ │ │ ├── hdg_MappingProjection_second_onlyf.m~ │ │ ├── hdg_Mapping_auxDt.m │ │ ├── hdg_Matrix.m │ │ ├── hdg_PostprocessMatrix.m │ │ ├── hdg_PostprocessSolution.m │ │ ├── hdg_PrecalculatedConvectionTensor.m │ │ ├── hdg_PrecalculatedConvectionTensor.m~ │ │ ├── hdg_PrecalculatedConvectionTensor_newBC.m~ │ │ ├── hdg_PrecalculatedMatrices.asv │ │ ├── hdg_PrecalculatedMatrices.m │ │ ├── hdg_PrecalculatedMatrices3D.m │ │ ├── hdg_Preprocess.m │ │ ├── hdg_ShockCapturing.m │ │ ├── hdg_bc (giorgio-laptop's conflicted copy 2017-12-06).m │ │ ├── hdg_bc.m │ │ ├── hdg_bc3d.m │ │ ├── setPeriodicBoundary.m │ │ └── setPeriodicBoundary.m~ │ ├── MHD │ │ ├── JacobDecomp.mw │ │ ├── analyticalSolution.m │ │ ├── analyticalSolution3d.m │ │ ├── bodyForce.m │ │ ├── bodyForce3d.m │ │ ├── checkProblem.m │ │ ├── computeLocalDiffusionInPoints.m │ │ ├── defineMagneticField.m │ │ ├── defineMagneticField3d.m │ │ ├── initializeSolution.m │ │ ├── initializeSolutionToAnalyticalSol.m │ │ ├── initializeSolutionWithL2Projection.m │ │ ├── magneticField.mw │ │ ├── magneticField_MAS.bak │ │ ├── old │ │ │ ├── setDirichletBoundaryConditions.m │ │ │ └── setDirichletBoundaryConditions_old.m │ │ ├── setDirichletFaces (giorgio-laptop's conflicted copy 2017-12-06).m │ │ ├── setDirichletFaces.m │ │ ├── shapefunctions.mw │ │ └── shapefunctions_MAS.bak │ ├── MHDIsotherme_HDG.m │ ├── MHDIsotherme_HDG_3D.m │ ├── Utilities │ │ ├── GenerateMatFileFromEZ4U.m │ │ ├── Re%3a_Routines_for_plotting_HDG_solution_along_a_line_%28interpolating_the_solution_at_points%29.zip │ │ ├── analyseBoundaryWest.m │ │ ├── blendingboundary.m │ │ ├── boundaryLayerProperties.asv │ │ ├── boundaryLayerProperties.m │ │ ├── calculateElementByElementGradient.m │ │ ├── calculateL2ErrorTwoSolutionDifferentP.m │ │ ├── calculateL2ErrorTwoSolutionDifferentP.m~ │ │ ├── calculateL2ErrorTwoSolutionDifferentP_scalar.m │ │ ├── calculateL2ErrorTwoSolutionNested.m │ │ ├── checkMapping.m │ │ ├── checkMapping3d.m │ │ ├── checksolution.m │ │ ├── col.m │ │ ├── colt.m │ │ ├── computeErrorAnalyticSol.m │ │ ├── computeErrorVelocity.m │ │ ├── computeError_3D.m │ │ ├── computeGradPerp.m │ │ ├── computeGradPerp.m~ │ │ ├── computeImageHighOrderRepresentation.m │ │ ├── computeLiftDragTorque.m │ │ ├── computeLiftDragTorque.m~ │ │ ├── computeResiduals_global.m │ │ ├── computeResiduals_global_alt.m │ │ ├── computeResiduals_local.m │ │ ├── computeResiduals_local_3d.m │ │ ├── computeResiduals_local_analiticalGrad.m │ │ ├── computeResiduals_local_analiticalGrad_3d.m │ │ ├── computeSourceIntgral.m │ │ ├── createBackgroundMesh.m │ │ ├── createContinuousSolution_scal.m │ │ ├── createContinuousSolution_vec.m │ │ ├── createCrossConnectivity.m │ │ ├── createRuledConnectivity.m │ │ ├── defineStartingPoints.m │ │ ├── export_fig.m │ │ ├── extractFaceSolution.m │ │ ├── extractFaceSolution_3d.m │ │ ├── extractSolutionInAPoloidalPlane.m │ │ ├── extractSolutionInAtGivenTheta.m │ │ ├── findCoeffShockCaptur.m │ │ ├── findElementSize.m │ │ ├── findNegativeJacobians.m │ │ ├── firstElementLayer.m │ │ ├── fixDataWithRepeatedNodes.m │ │ ├── fixMeshWithRepeatedNodes.m │ │ ├── fixMeshes.m │ │ ├── getEdge_tri.m │ │ ├── getHOcurve.m │ │ ├── getHOcurve_preComputations.m │ │ ├── gmres_r.m │ │ ├── initializeSolutionToAnalyticalSol_3D.m │ │ ├── nElementLayer.m │ │ ├── plotBoundary.m │ │ ├── plotConstantElementalValue.m │ │ ├── plotCp.m │ │ ├── plotCpOnAirfoil.m │ │ ├── plotDensityDiscontinuous.m │ │ ├── plotDetachmentPoint.m │ │ ├── plotDetachmentPoint.m~ │ │ ├── plotDiamagDrift.m │ │ ├── plotDiscontinuousSolution.m │ │ ├── plotError.m │ │ ├── plotErrorExactSol.m │ │ ├── plotErrorExactSol.m~ │ │ ├── plotErrorMap.m │ │ ├── plotErrorMap_new.asv │ │ ├── plotErrorMap_new.m │ │ ├── plotFaceVelocity.m │ │ ├── plotMesh (giorgio-laptop's conflicted copy 2017-12-06).m │ │ ├── plotMesh.m │ │ ├── plotMesh_HOElement.m │ │ ├── plotMesh_HOElement_mod.m │ │ ├── plotParallelVelocityDiscontinuous.m │ │ ├── plotParallelVelocityVector.m │ │ ├── plotPressure.m │ │ ├── plotSkinFrictionCoeff.m │ │ ├── plotSkinFrictionCoeff.m~ │ │ ├── plotSolution (giorgio-laptop's conflicted copy 2017-12-06).m │ │ ├── plotSolution.m │ │ ├── plotSolutionDifference.m │ │ ├── plotSolutionOnALine.m │ │ ├── plotSolutionOnBoundary.m │ │ ├── plotSourcesWest.m │ │ ├── plotStreamLines.m │ │ ├── plotStreamlinesWithStreamFunction.m │ │ ├── plotVelocity.m │ │ ├── plotroutine │ │ │ ├── HDGtoFineLinearApproximation.m │ │ │ ├── SoniaPostprocessExample2.m │ │ │ ├── computeShapeFunctionsAtPoints.m │ │ │ ├── evalDGapproximationAtPoints.m │ │ │ ├── findElementForx.m │ │ │ ├── fnonlinearInverseIsoTrans.m │ │ │ ├── inverseIsopTransf.m │ │ │ ├── inverseIsoparametricTransformation.m │ │ │ ├── inverseLinearTransformation.m │ │ │ ├── isoparametricTransformationHighOrder.m │ │ │ ├── testFindElementForx.m │ │ │ └── testInverseIsoparametricTransformation.m │ │ ├── postprocess_CircularCaseLimiter.m │ │ ├── print2eps.m │ │ ├── projectFieldDifferentP.m │ │ ├── readyforprintjpeg (giorgio-laptop's conflicted copy 2017-12-06).m │ │ ├── readyforprintjpeg.m │ │ ├── readyforprintnew (giorgio-laptop's conflicted copy 2017-12-06).m │ │ ├── readyforprintnew.m │ │ ├── rotationStructure.mat │ │ ├── saveData.m │ │ ├── saveSolutionWithParametersName.m │ │ ├── setNeumannFaces.m │ │ ├── setperm.m │ │ ├── setperm3d.m │ │ ├── storeSolution.m │ │ ├── store_simulation_parameters.m │ │ ├── structCompare.m │ │ ├── thwaites.m │ │ ├── thwaites.m~ │ │ ├── tricontour.m │ │ ├── tricontour_h.m │ │ ├── tryAnalyticalSol.m │ │ └── using_hg2.m │ ├── aux_plotSolLineDifferetDiff.m │ ├── aux_plot_nodes.m │ ├── auxplotconv.m │ ├── checkFortMapping.m │ ├── checkParallMatrix.m │ ├── compare_serial_to_parallel.m │ ├── convertFortranSolutionToMatlab │ ├── convertFortranSolutionToMatlab.m │ ├── debugFortran.m │ ├── interpolateStatesEvolvingEquilibrium.m │ ├── loadData.m │ ├── loadMagneticField.m │ ├── matlabShapeFunctions │ │ ├── GaussLegendreCubature2D.m │ │ ├── Vandermonde_LP.m │ │ ├── computeShapeFunctionsQua.m │ │ ├── computeShapeFunctionsReferenceElement.m │ │ ├── createReferenceElement.m │ │ ├── createShapeFunctions2dTensor.m │ │ ├── feketeNodes1D.m │ │ ├── feketeNodesTri2D.m │ │ ├── gaussLegendre.m │ │ ├── getPermutationsQuads.m │ │ ├── orthopoly │ │ │ ├── Vandermonde_LP.m │ │ │ ├── jacobiPol.m │ │ │ ├── mapXiEtaZeta2rst.m │ │ │ ├── orthopoly1D.m │ │ │ ├── orthopoly1D_deriv.m │ │ │ ├── orthopoly2D.m │ │ │ ├── orthopoly2D_deriv_rst.m │ │ │ ├── orthopoly2D_deriv_xieta.m │ │ │ ├── orthopoly2D_rst.m │ │ │ ├── orthopoly3D.m │ │ │ ├── orthopoly3D_deriv_rst.m │ │ │ └── orthopoly3D_rst.m │ │ ├── permutations_quads.m │ │ └── positionFeketeNodesTri2D_EZ4U.mat │ ├── plotDensVsTimeGoldston.m │ ├── plotEvolvingEquilibrium.m │ ├── plotFortranSolution.m │ ├── plotFortranSolution_parallel.m │ ├── plotMagneticFieldCircularMesh.m │ ├── plotShockCapturingDiff.m │ ├── plotSolOnGivenLine.m │ ├── plotSolOnGivenLineWest.m │ ├── plotSolutionEvolvingEquilibrium.m │ ├── plotTauOnFaces.m │ ├── plot_zones.m │ ├── postprocessSol.m │ ├── postprocessSol_WestDiffHoles.m │ ├── postprocessSol_WestDiffHoles_Project.m │ ├── postprocessSol_WestHugo (giorgio-laptop's conflicted copy 2017-12-06).m~ │ ├── postprocessSol_WestHugo.m │ ├── postprocessWestHoleNoHole.m │ ├── prepostGoldstone.m │ ├── projectSolutionDifferentMeshes.m │ ├── projectUtildeDifferentP.m │ ├── prova.m │ ├── prova2.m │ ├── prova_2.m │ ├── readCSRVectortxt.m │ ├── readCSRVectortxtParall.m │ ├── readCSRtxt.m │ ├── readCSRtxtParall.m │ ├── readMatTxt.m │ ├── setpath.m │ ├── shockCaptPrep.m │ ├── symbRHSIsoth.m │ ├── symbolic_magnetic_field_circ.m │ ├── test.m │ ├── test2.m │ ├── testMatrixParallSerial.m │ ├── testSlope.m │ ├── untitled4.m │ └── untitled40.m ├── MHD_NGammaTiTe │ ├── Convergence.m │ ├── Convergence_p.m │ ├── FindCoefficients.m │ ├── GenerateHOMeshesCircGeomWithLim.m │ ├── HDF5readCSRmat.m │ ├── HDF5readmat.m │ ├── HDG │ │ ├── GetFaces.m │ │ ├── calculateElementByElementSolution.m │ │ ├── calculateElementByElementVelocityGradient.m │ │ ├── computeElementByElementGradient_3D.m │ │ ├── computeElementByElementSolution_3D.m │ │ ├── hdg_AddDiffForLimitingRho.m │ │ ├── hdg_Assembly.m │ │ ├── hdg_Assembly_3D.m │ │ ├── hdg_ConvectionMatrices.m │ │ ├── hdg_ConvectionMatrices_3D.m │ │ ├── hdg_IterativeSolver.asv │ │ ├── hdg_IterativeSolver.m │ │ ├── hdg_LocalDiffusionInPoints.m │ │ ├── hdg_Mapping.m │ │ ├── hdg_MappingProject.m │ │ ├── hdg_Mapping_3D.m │ │ ├── hdg_Mapping_auxDt.m │ │ ├── hdg_Matrix.m │ │ ├── hdg_ParallDiffusionEnergyMatrix.m │ │ ├── hdg_ParallDiffusionEnergyMatrix_3D.m │ │ ├── hdg_PostprocessMatrix.m │ │ ├── hdg_PostprocessSolution.m │ │ ├── hdg_PrecalculatedConvectionTensor.m │ │ ├── hdg_PrecalculatedMatrices.asv │ │ ├── hdg_PrecalculatedMatrices.m │ │ ├── hdg_PrecalculatedMatrices3D.m │ │ ├── hdg_Preprocess.m │ │ ├── hdg_ShockCapturing.m │ │ ├── hdg_bc.m │ │ ├── hdg_bc_3D.m │ │ ├── hdg_bc_3D_aux.m │ │ ├── hdg_bc_3D_old.m │ │ └── setPeriodicBoundary.m │ ├── MHD │ │ ├── EigenvaluesJ.mw │ │ ├── analyticalSolution.m │ │ ├── analyticalSolution_3D.m │ │ ├── bf1_3D.m │ │ ├── bf2.m │ │ ├── bf24.m │ │ ├── bf25.m │ │ ├── bf26.m │ │ ├── bf2_3D.m │ │ ├── bf3.m │ │ ├── bf4.m │ │ ├── bf5.m │ │ ├── bf6.m │ │ ├── bodyForce.m │ │ ├── bodyForce_3D.m │ │ ├── bodyForce_3D_new.m │ │ ├── bodyForce_3D_old.m │ │ ├── checkProblem.m │ │ ├── computeLocalDiffusionInPoints.m │ │ ├── cons2phys.m │ │ ├── defineMagneticField.m │ │ ├── defineMagneticField_3D.m │ │ ├── initializeSolution.m │ │ ├── initializeSolutionToAnalyticalSol.m │ │ ├── initializeSolutionToAnalyticalSol_3D.m │ │ ├── initializeSolutionWithL2Projection.m │ │ ├── loadMagneticField.m │ │ ├── rhsbohm.m │ │ └── setDirichletFaces.m │ ├── MHDG_NGammaTiTe.m │ ├── MHDG_NGammaTiTe3D.m │ ├── Utilities │ │ ├── CreaMalla.m │ │ ├── GenerateMatFileFromEZ4U.m │ │ ├── GetFaces_mod.m │ │ ├── GetFaces_mod.m~ │ │ ├── HDF5load.m │ │ ├── blendingboundary.m │ │ ├── boundaryLayerProperties.asv │ │ ├── boundaryLayerProperties.m │ │ ├── calculateElementByElementGradient.m │ │ ├── calculateL2ErrorTwoSolutionDifferentP.m │ │ ├── calculateL2ErrorTwoSolutionDifferentP_scalar.m │ │ ├── calculateL2ErrorTwoSolutionNested.m │ │ ├── checkMapping.m │ │ ├── checksolution.m │ │ ├── col.m │ │ ├── colt.m │ │ ├── computeErrorAnalyticSol.m │ │ ├── computeErrorVelocity.m │ │ ├── computeError_3D.m │ │ ├── computeGradPerp.m │ │ ├── computeImageHighOrderRepresentation.m │ │ ├── computeLiftDragTorque.m │ │ ├── computeResiduals_global.m │ │ ├── computeResiduals_global_alt.m │ │ ├── computeResiduals_local.m │ │ ├── computeResiduals_local_analiticalGrad.m │ │ ├── computeResiduals_local_analiticalGrad_3D.m │ │ ├── computeSourceIntgral.m │ │ ├── converFortranSolutionToMatlab.m │ │ ├── createBackgroundMesh.m │ │ ├── createContinuousSolution_scal.m │ │ ├── createContinuousSolution_vec.m │ │ ├── createCrossConnectivity.m │ │ ├── createRuledConnectivity.m │ │ ├── defineStartingPoints.m │ │ ├── export_fig.m │ │ ├── extractFaceSolution.m │ │ ├── extractFaceSolution_3d.m │ │ ├── findCoeffShockCaptur.m │ │ ├── findElementSize.m │ │ ├── findNegativeJacobians.m │ │ ├── findface.m │ │ ├── firstElementLayer.m │ │ ├── fixDataWithRepeatedNodes.m │ │ ├── fixMeshWithRepeatedNodes.m │ │ ├── fixMeshes.m │ │ ├── getEdge_tri.m │ │ ├── getHOcurve.m │ │ ├── getHOcurve_preComputations.m │ │ ├── gmres_r.m │ │ ├── linearMapping.m │ │ ├── linearMappingQua.m │ │ ├── nElementLayer.m │ │ ├── plotBoundary.m │ │ ├── plotConstantElementalValue.m │ │ ├── plotCp.m │ │ ├── plotCpOnAirfoil.m │ │ ├── plotDensityDiscontinuous.m │ │ ├── plotDetachmentPoint.m │ │ ├── plotDiamagDrift.m │ │ ├── plotDiscontinuousSolution.m │ │ ├── plotError.m │ │ ├── plotErrorExactSol.m │ │ ├── plotErrorMap.m │ │ ├── plotErrorMap_new.asv │ │ ├── plotErrorMap_new.m │ │ ├── plotFaceVelocity.m │ │ ├── plotMesh.m │ │ ├── plotMesh_HOElement.m │ │ ├── plotMesh_HOElement_mod.m │ │ ├── plotParallelVelocityDiscontinuous.m │ │ ├── plotParallelVelocityVector.m │ │ ├── plotPressure.m │ │ ├── plotSkinFrictionCoeff.m │ │ ├── plotSolution.m │ │ ├── plotSolutionDifference.m │ │ ├── plotSolutionOnALine.m │ │ ├── plotSolutionPhys.m │ │ ├── plotSourcesWest.m │ │ ├── plotStreamLines.m │ │ ├── plotStreamlinesWithStreamFunction.m │ │ ├── plotVelocity.m │ │ ├── plotroutine │ │ │ ├── HDGtoFineLinearApproximation.m │ │ │ ├── SoniaPostprocessExample2.m │ │ │ ├── computeShapeFunctionsAtPoints.m │ │ │ ├── computeShapeFunctionsAtPointsQuads.m │ │ │ ├── evalDGapproximationAtPoints.m │ │ │ ├── findElementForx.m │ │ │ ├── fnonlinearInverseIsoTrans.m │ │ │ ├── inverseIsopTransf.m │ │ │ ├── inverseIsoparametricTransformation.m │ │ │ ├── inverseLinearTransformation.m │ │ │ ├── inverseLinearTransformationQua.m │ │ │ ├── isoparametricTransformationHighOrder.m │ │ │ ├── isoparametricTransformationHighOrderQua.m │ │ │ ├── testFindElementForx.m │ │ │ └── testInverseIsoparametricTransformation.m │ │ ├── postprocess_CircularCaseLimiter.m │ │ ├── print2eps.m │ │ ├── projectFieldDifferentP.m │ │ ├── prolExp.m │ │ ├── readMatTxt.m │ │ ├── readyforprintjpeg.m │ │ ├── readyforprintnew.m │ │ ├── rotationStructure.mat │ │ ├── saveData.m │ │ ├── saveSolutionWithParametersName.m │ │ ├── sawMeshes.m │ │ ├── setBoundarySquareMesh.m │ │ ├── setNeumannFaces.m │ │ ├── setOrderLinearMesh.m │ │ ├── setperm.m │ │ ├── setperm3d.m │ │ ├── storeSolution.m │ │ ├── store_simulation_parameters.m │ │ ├── structCompare.m │ │ ├── thwaites.m │ │ ├── tricontour.m │ │ ├── tryAnalyticalSol.m │ │ └── using_hg2.m │ ├── auxplot_SolutionOnLline.m │ ├── auxplotconv.m │ ├── checkMappingWest.m │ ├── cleanBackupFiles.m │ ├── computeIntSol.m │ ├── convExpress2Fort.m │ ├── convertMatrixCSRtoIJK.m │ ├── debugFortran.m │ ├── expandMatrixA_mult.m │ ├── expand_matrix.m │ ├── extractSolutionInAtGivenTheta.m │ ├── filterSolution.m │ ├── filterSolutionElement.m │ ├── fortrantest │ ├── ftest │ ├── impthr.m │ ├── loadData.m │ ├── magnetic_field_case60.m │ ├── matlabShapeFunctions │ │ ├── GaussLegendreCubature2D.m │ │ ├── ProvaComputeShapeFunctionsReferenceElementQuads.m │ │ ├── Vandermonde_LP.m │ │ ├── Vandermonde_LP2D_Quad.m │ │ ├── computeShapeFunctionsQua.m │ │ ├── computeShapeFunctionsReferenceElement.m │ │ ├── createReferenceElement.m │ │ ├── createShapeFunctions2dTensor.m │ │ ├── feketeNodes1D.m │ │ ├── feketeNodesTri2D.m │ │ ├── gaussLegendre.m │ │ ├── getPermutationsQuads.m │ │ ├── orthopoly │ │ │ ├── Vandermonde_LP.m │ │ │ ├── jacobiPol.m │ │ │ ├── mapXiEtaZeta2rst.m │ │ │ ├── orthopoly1D.m │ │ │ ├── orthopoly1D_deriv.m │ │ │ ├── orthopoly2D.m │ │ │ ├── orthopoly2D_deriv_rst.m │ │ │ ├── orthopoly2D_deriv_xieta.m │ │ │ ├── orthopoly2D_rst.m │ │ │ ├── orthopoly3D.m │ │ │ ├── orthopoly3D_deriv_rst.m │ │ │ └── orthopoly3D_rst.m │ │ ├── permutations_quads.m │ │ └── positionFeketeNodesTri2D_EZ4U.mat │ ├── plotFortranSolution.m │ ├── plotFortranSolution_difference.m │ ├── plotFortranSolution_parallel.m │ ├── plotTauOnFaces.m │ ├── prova.m │ ├── prova2.m │ ├── prova_eig.m │ ├── readCSRVectortxt.m │ ├── readCSRVectortxtParall.m │ ├── readCSRtxt.m │ ├── readCSRtxtParall.m │ ├── readMatTxt.m │ ├── setpath.m │ ├── symbEig.m │ ├── symbEigBohm.m │ ├── symbEig_NGamma.m │ ├── symbRHSAnisoth.m │ ├── test.m │ ├── testWest.m │ ├── testWestNew.m │ └── testglo.m ├── Meshes │ ├── CircLimAlign_Quads_Nel208_P4.mat │ ├── Circle_LIM_InfThin_h0.1_RefCorn0.02_P4.mat │ ├── CreaMalla.m │ ├── DomainDecomposition.m │ ├── GenerateHDF5_meshes.m │ ├── GenerateHDF5_meshes_Parallel.m │ ├── GenerateHOMeshesCircGeomWithLim.m │ ├── GetFaces.m │ ├── GetFaces_mod.m │ ├── HDF5load.m │ ├── West_h0.04_refCorn_P4.mat │ ├── convertMatMeshToHDF5.m │ ├── findface.m │ ├── linearMappingQua.m │ ├── sawMeshes.m │ ├── setBoundarySquareMesh.m │ └── setOrderLinearMesh.m ├── Postprocess │ ├── FindCoefficients.m │ ├── HDF5load.m │ ├── checkDimensions.m │ ├── col.m │ ├── colt.m │ ├── cons2phys.m │ ├── createReferenceElement.m │ ├── extractSolutionInAtGivenTheta.m │ ├── orthopoly │ │ ├── GaussLegendreCubature2D.m │ │ ├── Vandermonde_LP.m │ │ ├── computeShapeFunctionsQua.m │ │ ├── computeShapeFunctionsReferenceElement.m │ │ ├── createReferenceElement.m │ │ ├── createShapeFunctions2dTensor.m │ │ ├── feketeNodes1D.m │ │ ├── feketeNodesTri2D.m │ │ ├── gaussLegendre.m │ │ ├── getPermutationsQuads.m │ │ ├── jacobiPol.m │ │ ├── mapXiEtaZeta2rst.m │ │ ├── orthopoly1D.m │ │ ├── orthopoly1D_deriv.m │ │ ├── orthopoly2D.m │ │ ├── orthopoly2D_deriv_rst.m │ │ ├── orthopoly2D_deriv_xieta.m │ │ ├── orthopoly2D_rst.m │ │ ├── orthopoly3D.m │ │ ├── orthopoly3D_deriv_rst.m │ │ ├── orthopoly3D_rst.m │ │ ├── permutations_quads.m │ │ └── positionFeketeNodesTri2D_EZ4U.mat │ ├── plotFortranSolution.m │ ├── plotMesh.m │ ├── plotSolution.m │ ├── prova.m │ ├── readyforprintjpeg.m │ ├── readyforprintnew.m │ └── setpath.m └── Preprocess │ ├── CreaMalla.m │ ├── DomainDecomposition.m │ ├── DomainDecomposition.m~ │ ├── FindCoefficients.m │ ├── GenerateHDF5_meshes_Parallel.m │ ├── GenerateHOMeshesCircGeomWithLim.m │ ├── GetFaces.m │ ├── GetFaces_mod.m │ ├── HDF5load.m │ ├── checkDimensions.m │ ├── col.m │ ├── colt.m │ ├── compute_balance.m │ ├── compute_balance_it.m │ ├── compute_balance_it.m~ │ ├── convertMatMeshToHDF5.m │ ├── createReferenceElement.m │ ├── extractSolutionInAtGivenTheta.m │ ├── findface.m │ ├── linearMappingQua.m │ ├── orthopoly │ ├── GaussLegendreCubature2D.m │ ├── Vandermonde_LP.m │ ├── computeShapeFunctionsQua.m │ ├── computeShapeFunctionsReferenceElement.m │ ├── createReferenceElement.m │ ├── createShapeFunctions2dTensor.m │ ├── feketeNodes1D.m │ ├── feketeNodesTri2D.m │ ├── gaussLegendre.m │ ├── getPermutationsQuads.m │ ├── jacobiPol.m │ ├── mapXiEtaZeta2rst.m │ ├── orthopoly1D.m │ ├── orthopoly1D_deriv.m │ ├── orthopoly2D.m │ ├── orthopoly2D_deriv_rst.m │ ├── orthopoly2D_deriv_xieta.m │ ├── orthopoly2D_rst.m │ ├── orthopoly3D.m │ ├── orthopoly3D_deriv_rst.m │ ├── orthopoly3D_rst.m │ ├── permutations_quads.m │ └── positionFeketeNodesTri2D_EZ4U.mat │ ├── plotFortranSolution.m~ │ ├── plotMesh.m │ ├── sawMeshes.m │ ├── setBoundarySquareMesh.m │ ├── setOrderLinearMesh.m │ └── setpath.m ├── src ├── Convergence.f90 ├── Definitions │ ├── globals.f90 │ ├── prec_const.f90 │ └── types.f90 ├── HDG │ ├── compute_element_solution.f90 │ ├── hdg_Assembly.f90 │ ├── hdg_BC.f90 │ ├── hdg_ComputeJacobian.f90 │ ├── hdg_LimitingTechniques.f90 │ ├── hdg_Mapping.f90 │ ├── hdg_PrecalculatedFirstEquation.f90 │ ├── initialization.f90 │ ├── preprocess.f90 │ ├── reference_element.f90 │ └── solve_global_system.f90 ├── InOut │ ├── HDF5_io.f90 │ ├── Postprocess.f90 │ ├── inout.f90 │ ├── prova.f90 │ └── read_input.f90 ├── LinearAlgebra │ ├── LinearAlgebra.f90 │ ├── interpolation.f90 │ ├── matrices_tools.f90 │ ├── matrices_types.f90 │ ├── solve_pastix.f90 │ └── solve_psblas.f90 ├── MHDG.f90 ├── MPI_OMP │ ├── Communications.f90 │ └── MPI_OMP.f90 ├── Models │ ├── Laplace │ │ ├── analytical.f90 │ │ └── physics.f90 │ ├── NGamma │ │ ├── analytical.f90 │ │ └── physics.f90 │ ├── NGammaLaplace │ │ ├── analytical.f90 │ │ └── physics.f90 │ ├── NGammaTiTe │ │ ├── analytical.f90 │ │ └── physics.f90 │ ├── NGammaVort │ │ ├── analytical.f90 │ │ └── physics.f90 │ ├── adimensionalization.f90 │ └── magnetic_field.f90 └── Utils │ ├── Debug.f90 │ └── PrintUtils.f90 └── test ├── CircLimAlign_Quads_Nel208_P4.h5 ├── CircLimAlign_Quads_Nel208_P4_1_4.h5 ├── CircLimAlign_Quads_Nel208_P4_1_8.h5 ├── CircLimAlign_Quads_Nel208_P4_2_4.h5 ├── CircLimAlign_Quads_Nel208_P4_2_8.h5 ├── CircLimAlign_Quads_Nel208_P4_3_4.h5 ├── CircLimAlign_Quads_Nel208_P4_3_8.h5 ├── CircLimAlign_Quads_Nel208_P4_4_4.h5 ├── CircLimAlign_Quads_Nel208_P4_4_8.h5 ├── CircLimAlign_Quads_Nel208_P4_5_8.h5 ├── CircLimAlign_Quads_Nel208_P4_6_8.h5 ├── CircLimAlign_Quads_Nel208_P4_7_8.h5 ├── CircLimAlign_Quads_Nel208_P4_8_8.h5 ├── Square_1_P1.h5 ├── Square_1_P2.h5 ├── Square_1_P3.h5 ├── Square_1_P4.h5 ├── Square_1_P5.h5 ├── Square_2_P1.h5 ├── Square_2_P2.h5 ├── Square_2_P3.h5 ├── Square_2_P4.h5 ├── Square_2_P5.h5 ├── Square_3_P1.h5 ├── Square_3_P2.h5 ├── Square_3_P3.h5 ├── Square_3_P4.h5 ├── Square_3_P5.h5 ├── Square_4_P1.h5 ├── Square_4_P2.h5 ├── Square_4_P3.h5 ├── Square_4_P4.h5 ├── Square_4_P5.h5 ├── Square_5_P1.h5 ├── Square_5_P2.h5 ├── Square_5_P3.h5 ├── Square_5_P4.h5 ├── Square_5_P5.h5 ├── Square_6_P1.h5 ├── Square_6_P2.h5 ├── Square_6_P3.h5 ├── Square_6_P4.h5 ├── Square_6_P5.h5 ├── param.txt ├── positionFeketeNodesTri2D.h5 ├── prova └── setPerpDiff.sh /.gitignore: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/.gitignore -------------------------------------------------------------------------------- /README.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/README.md -------------------------------------------------------------------------------- /latex/NGammaTiTe.pdf: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/latex/NGammaTiTe.pdf -------------------------------------------------------------------------------- /latex/NGammaTiTe.tex: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/latex/NGammaTiTe.tex -------------------------------------------------------------------------------- /lib/Make.inc/arch.make: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/lib/Make.inc/arch.make -------------------------------------------------------------------------------- /lib/Make.inc/arch.make_marconi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/lib/Make.inc/arch.make_marconi -------------------------------------------------------------------------------- /lib/Make.inc/arch.make_meso: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/lib/Make.inc/arch.make_meso -------------------------------------------------------------------------------- /lib/Makefile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/lib/Makefile -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/BackgroundMesh.sub: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/BackgroundMesh.sub -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Convergence.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Convergence.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Convergence_p.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Convergence_p.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/FindCoefficients.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/FindCoefficients.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Goldston_New.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Goldston_New.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Goldstone_Postprocess.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Goldstone_Postprocess.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Goldstone_Postprocess_Curvature.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Goldstone_Postprocess_Curvature.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDF5load.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDF5load.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/GetFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/GetFaces.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/calculateElementByElementSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/calculateElementByElementSolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/calculateElementByElementSolutionProjection_second.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/calculateElementByElementSolutionProjection_second.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/calculateElementByElementVelocityGradient.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/calculateElementByElementVelocityGradient.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/computeElementByElementGradient3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/computeElementByElementGradient3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/computeElementByElementSolution3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/computeElementByElementSolution3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_AddDiffForLimitingRho.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_AddDiffForLimitingRho.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_Assembly.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_Assembly.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_Assembly3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_Assembly3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_AssemblyProjection_first.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_AssemblyProjection_first.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_AssemblyProjection_second.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_AssemblyProjection_second.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices_3D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices_NEW.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices_NEW.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices_newBC.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices_newBC.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices_noVec.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_ConvectionMatrices_noVec.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_IterativeSolver.asv: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_IterativeSolver.asv -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_IterativeSolver.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_IterativeSolver.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_IterativeSolver.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_IterativeSolver.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_LocalDiffusionInPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_LocalDiffusionInPoints.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_Mapping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_Mapping.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_Mapping3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_Mapping3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_MappingPrecond.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_MappingPrecond.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_MappingProject.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_MappingProject.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_MappingProject.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_MappingProject.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_MappingProjection_first.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_MappingProjection_first.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_MappingProjection_second.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_MappingProjection_second.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_MappingProjection_second_onlyf.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_MappingProjection_second_onlyf.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_Mapping_auxDt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_Mapping_auxDt.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_Matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_Matrix.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_PostprocessMatrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_PostprocessMatrix.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_PostprocessSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_PostprocessSolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedConvectionTensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedConvectionTensor.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedConvectionTensor.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedConvectionTensor.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedConvectionTensor_newBC.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedConvectionTensor_newBC.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedMatrices.asv: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedMatrices.asv -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedMatrices.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedMatrices.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedMatrices3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_PrecalculatedMatrices3D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_Preprocess.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_Preprocess.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_ShockCapturing.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_ShockCapturing.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_bc (giorgio-laptop's conflicted copy 2017-12-06).m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_bc (giorgio-laptop's conflicted copy 2017-12-06).m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_bc.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_bc.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/hdg_bc3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/hdg_bc3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/setPeriodicBoundary.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/setPeriodicBoundary.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/HDG/setPeriodicBoundary.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/HDG/setPeriodicBoundary.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/JacobDecomp.mw: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/JacobDecomp.mw -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/analyticalSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/analyticalSolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/analyticalSolution3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/analyticalSolution3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/bodyForce.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/bodyForce.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/bodyForce3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/bodyForce3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/checkProblem.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/checkProblem.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/computeLocalDiffusionInPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/computeLocalDiffusionInPoints.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/defineMagneticField.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/defineMagneticField.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/defineMagneticField3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/defineMagneticField3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/initializeSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/initializeSolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/initializeSolutionToAnalyticalSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/initializeSolutionToAnalyticalSol.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/initializeSolutionWithL2Projection.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/initializeSolutionWithL2Projection.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/magneticField.mw: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/magneticField.mw -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/magneticField_MAS.bak: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/magneticField_MAS.bak -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/old/setDirichletBoundaryConditions.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/old/setDirichletBoundaryConditions.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/old/setDirichletBoundaryConditions_old.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/old/setDirichletBoundaryConditions_old.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/setDirichletFaces (giorgio-laptop's conflicted copy 2017-12-06).m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/setDirichletFaces (giorgio-laptop's conflicted copy 2017-12-06).m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/setDirichletFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/setDirichletFaces.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/shapefunctions.mw: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/shapefunctions.mw -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHD/shapefunctions_MAS.bak: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHD/shapefunctions_MAS.bak -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHDIsotherme_HDG.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHDIsotherme_HDG.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/MHDIsotherme_HDG_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/MHDIsotherme_HDG_3D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/GenerateMatFileFromEZ4U.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/GenerateMatFileFromEZ4U.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/Re%3a_Routines_for_plotting_HDG_solution_along_a_line_%28interpolating_the_solution_at_points%29.zip: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/Re%3a_Routines_for_plotting_HDG_solution_along_a_line_%28interpolating_the_solution_at_points%29.zip -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/analyseBoundaryWest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/analyseBoundaryWest.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/blendingboundary.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/blendingboundary.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/boundaryLayerProperties.asv: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/boundaryLayerProperties.asv -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/boundaryLayerProperties.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/boundaryLayerProperties.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/calculateElementByElementGradient.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/calculateElementByElementGradient.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/calculateL2ErrorTwoSolutionDifferentP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/calculateL2ErrorTwoSolutionDifferentP.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/calculateL2ErrorTwoSolutionDifferentP.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/calculateL2ErrorTwoSolutionDifferentP.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/calculateL2ErrorTwoSolutionDifferentP_scalar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/calculateL2ErrorTwoSolutionDifferentP_scalar.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/calculateL2ErrorTwoSolutionNested.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/calculateL2ErrorTwoSolutionNested.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/checkMapping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/checkMapping.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/checkMapping3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/checkMapping3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/checksolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/checksolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/col.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/col.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/colt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/colt.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeErrorAnalyticSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeErrorAnalyticSol.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeErrorVelocity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeErrorVelocity.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeError_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeError_3D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeGradPerp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeGradPerp.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeGradPerp.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeGradPerp.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeImageHighOrderRepresentation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeImageHighOrderRepresentation.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeLiftDragTorque.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeLiftDragTorque.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeLiftDragTorque.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeLiftDragTorque.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeResiduals_global.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeResiduals_global.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeResiduals_global_alt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeResiduals_global_alt.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeResiduals_local.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeResiduals_local.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeResiduals_local_3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeResiduals_local_3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeResiduals_local_analiticalGrad.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeResiduals_local_analiticalGrad.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeResiduals_local_analiticalGrad_3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeResiduals_local_analiticalGrad_3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/computeSourceIntgral.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/computeSourceIntgral.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/createBackgroundMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/createBackgroundMesh.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/createContinuousSolution_scal.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/createContinuousSolution_scal.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/createContinuousSolution_vec.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/createContinuousSolution_vec.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/createCrossConnectivity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/createCrossConnectivity.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/createRuledConnectivity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/createRuledConnectivity.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/defineStartingPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/defineStartingPoints.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/export_fig.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/export_fig.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/extractFaceSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/extractFaceSolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/extractFaceSolution_3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/extractFaceSolution_3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/extractSolutionInAPoloidalPlane.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/extractSolutionInAPoloidalPlane.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/extractSolutionInAtGivenTheta.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/extractSolutionInAtGivenTheta.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/findCoeffShockCaptur.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/findCoeffShockCaptur.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/findElementSize.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/findElementSize.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/findNegativeJacobians.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/findNegativeJacobians.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/firstElementLayer.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/firstElementLayer.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/fixDataWithRepeatedNodes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/fixDataWithRepeatedNodes.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/fixMeshWithRepeatedNodes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/fixMeshWithRepeatedNodes.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/fixMeshes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/fixMeshes.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/getEdge_tri.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/getEdge_tri.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/getHOcurve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/getHOcurve.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/getHOcurve_preComputations.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/getHOcurve_preComputations.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/gmres_r.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/gmres_r.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/initializeSolutionToAnalyticalSol_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/initializeSolutionToAnalyticalSol_3D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/nElementLayer.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/nElementLayer.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotBoundary.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotBoundary.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotConstantElementalValue.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotConstantElementalValue.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotCp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotCp.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotCpOnAirfoil.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotCpOnAirfoil.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotDensityDiscontinuous.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotDensityDiscontinuous.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotDetachmentPoint.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotDetachmentPoint.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotDetachmentPoint.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotDetachmentPoint.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotDiamagDrift.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotDiamagDrift.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotDiscontinuousSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotDiscontinuousSolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotError.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotError.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotErrorExactSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotErrorExactSol.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotErrorExactSol.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotErrorExactSol.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotErrorMap.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotErrorMap.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotErrorMap_new.asv: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotErrorMap_new.asv -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotErrorMap_new.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotErrorMap_new.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotFaceVelocity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotFaceVelocity.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotMesh (giorgio-laptop's conflicted copy 2017-12-06).m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotMesh (giorgio-laptop's conflicted copy 2017-12-06).m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotMesh.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotMesh_HOElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotMesh_HOElement.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotMesh_HOElement_mod.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotMesh_HOElement_mod.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotParallelVelocityDiscontinuous.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotParallelVelocityDiscontinuous.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotParallelVelocityVector.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotParallelVelocityVector.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotPressure.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotPressure.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotSkinFrictionCoeff.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotSkinFrictionCoeff.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotSkinFrictionCoeff.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotSkinFrictionCoeff.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotSolution (giorgio-laptop's conflicted copy 2017-12-06).m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotSolution (giorgio-laptop's conflicted copy 2017-12-06).m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotSolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotSolutionDifference.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotSolutionDifference.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotSolutionOnALine.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotSolutionOnALine.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotSolutionOnBoundary.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotSolutionOnBoundary.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotSourcesWest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotSourcesWest.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotStreamLines.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotStreamLines.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotStreamlinesWithStreamFunction.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotStreamlinesWithStreamFunction.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotVelocity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotVelocity.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/HDGtoFineLinearApproximation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/HDGtoFineLinearApproximation.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/SoniaPostprocessExample2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/SoniaPostprocessExample2.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/computeShapeFunctionsAtPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/computeShapeFunctionsAtPoints.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/evalDGapproximationAtPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/evalDGapproximationAtPoints.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/findElementForx.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/findElementForx.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/fnonlinearInverseIsoTrans.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/fnonlinearInverseIsoTrans.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/inverseIsopTransf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/inverseIsopTransf.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/inverseIsoparametricTransformation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/inverseIsoparametricTransformation.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/inverseLinearTransformation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/inverseLinearTransformation.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/isoparametricTransformationHighOrder.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/isoparametricTransformationHighOrder.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/testFindElementForx.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/testFindElementForx.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/plotroutine/testInverseIsoparametricTransformation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/plotroutine/testInverseIsoparametricTransformation.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/postprocess_CircularCaseLimiter.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/postprocess_CircularCaseLimiter.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/print2eps.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/print2eps.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/projectFieldDifferentP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/projectFieldDifferentP.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/readyforprintjpeg (giorgio-laptop's conflicted copy 2017-12-06).m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/readyforprintjpeg (giorgio-laptop's conflicted copy 2017-12-06).m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/readyforprintjpeg.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/readyforprintjpeg.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/readyforprintnew (giorgio-laptop's conflicted copy 2017-12-06).m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/readyforprintnew (giorgio-laptop's conflicted copy 2017-12-06).m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/readyforprintnew.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/readyforprintnew.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/rotationStructure.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/rotationStructure.mat -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/saveData.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/saveData.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/saveSolutionWithParametersName.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/saveSolutionWithParametersName.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/setNeumannFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/setNeumannFaces.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/setperm.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/setperm.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/setperm3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/setperm3d.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/storeSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/storeSolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/store_simulation_parameters.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/store_simulation_parameters.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/structCompare.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/structCompare.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/thwaites.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/thwaites.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/thwaites.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/thwaites.m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/tricontour.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/tricontour.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/tricontour_h.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/tricontour_h.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/tryAnalyticalSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/tryAnalyticalSol.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/Utilities/using_hg2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/Utilities/using_hg2.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/aux_plotSolLineDifferetDiff.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/aux_plotSolLineDifferetDiff.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/aux_plot_nodes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/aux_plot_nodes.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/auxplotconv.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/auxplotconv.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/checkFortMapping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/checkFortMapping.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/checkParallMatrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/checkParallMatrix.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/compare_serial_to_parallel.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/compare_serial_to_parallel.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/convertFortranSolutionToMatlab: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/convertFortranSolutionToMatlab -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/convertFortranSolutionToMatlab.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/convertFortranSolutionToMatlab.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/debugFortran.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/debugFortran.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/interpolateStatesEvolvingEquilibrium.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/interpolateStatesEvolvingEquilibrium.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/loadData.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/loadData.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/loadMagneticField.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/loadMagneticField.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/GaussLegendreCubature2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/GaussLegendreCubature2D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/Vandermonde_LP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/Vandermonde_LP.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/computeShapeFunctionsQua.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/computeShapeFunctionsQua.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/computeShapeFunctionsReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/computeShapeFunctionsReferenceElement.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/createReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/createReferenceElement.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/createShapeFunctions2dTensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/createShapeFunctions2dTensor.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/feketeNodes1D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/feketeNodes1D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/feketeNodesTri2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/feketeNodesTri2D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/gaussLegendre.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/gaussLegendre.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/getPermutationsQuads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/getPermutationsQuads.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/Vandermonde_LP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/Vandermonde_LP.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/jacobiPol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/jacobiPol.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/mapXiEtaZeta2rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/mapXiEtaZeta2rst.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly1D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly1D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly1D_deriv.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly1D_deriv.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly2D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly2D_deriv_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly2D_deriv_rst.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly2D_deriv_xieta.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly2D_deriv_xieta.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly2D_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly2D_rst.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly3D.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly3D_deriv_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly3D_deriv_rst.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly3D_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/orthopoly/orthopoly3D_rst.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/permutations_quads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/permutations_quads.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/matlabShapeFunctions/positionFeketeNodesTri2D_EZ4U.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/matlabShapeFunctions/positionFeketeNodesTri2D_EZ4U.mat -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotDensVsTimeGoldston.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotDensVsTimeGoldston.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotEvolvingEquilibrium.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotEvolvingEquilibrium.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotFortranSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotFortranSolution.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotFortranSolution_parallel.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotFortranSolution_parallel.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotMagneticFieldCircularMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotMagneticFieldCircularMesh.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotShockCapturingDiff.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotShockCapturingDiff.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotSolOnGivenLine.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotSolOnGivenLine.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotSolOnGivenLineWest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotSolOnGivenLineWest.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotSolutionEvolvingEquilibrium.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotSolutionEvolvingEquilibrium.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plotTauOnFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plotTauOnFaces.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/plot_zones.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/plot_zones.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/postprocessSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/postprocessSol.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/postprocessSol_WestDiffHoles.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/postprocessSol_WestDiffHoles.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/postprocessSol_WestDiffHoles_Project.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/postprocessSol_WestDiffHoles_Project.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/postprocessSol_WestHugo (giorgio-laptop's conflicted copy 2017-12-06).m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/postprocessSol_WestHugo (giorgio-laptop's conflicted copy 2017-12-06).m~ -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/postprocessSol_WestHugo.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/postprocessSol_WestHugo.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/postprocessWestHoleNoHole.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/postprocessWestHoleNoHole.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/prepostGoldstone.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/prepostGoldstone.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/projectSolutionDifferentMeshes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/projectSolutionDifferentMeshes.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/projectUtildeDifferentP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/projectUtildeDifferentP.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/prova.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/prova.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/prova2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/prova2.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/prova_2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/prova_2.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/readCSRVectortxt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/readCSRVectortxt.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/readCSRVectortxtParall.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/readCSRVectortxtParall.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/readCSRtxt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/readCSRtxt.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/readCSRtxtParall.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/readCSRtxtParall.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/readMatTxt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/readMatTxt.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/setpath.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/setpath.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/shockCaptPrep.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/shockCaptPrep.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/symbRHSIsoth.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/symbRHSIsoth.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/symbolic_magnetic_field_circ.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/symbolic_magnetic_field_circ.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/test.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/test.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/test2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/test2.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/testMatrixParallSerial.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/testMatrixParallSerial.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/testSlope.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/testSlope.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/untitled4.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/untitled4.m -------------------------------------------------------------------------------- /matlab/MHD_HDG_isotherm/untitled40.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_HDG_isotherm/untitled40.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Convergence.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Convergence.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Convergence_p.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Convergence_p.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/FindCoefficients.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/FindCoefficients.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/GenerateHOMeshesCircGeomWithLim.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/GenerateHOMeshesCircGeomWithLim.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDF5readCSRmat.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDF5readCSRmat.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDF5readmat.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDF5readmat.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/GetFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/GetFaces.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/calculateElementByElementSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/calculateElementByElementSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/calculateElementByElementVelocityGradient.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/calculateElementByElementVelocityGradient.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/computeElementByElementGradient_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/computeElementByElementGradient_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/computeElementByElementSolution_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/computeElementByElementSolution_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_AddDiffForLimitingRho.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_AddDiffForLimitingRho.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_Assembly.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_Assembly.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_Assembly_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_Assembly_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_ConvectionMatrices.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_ConvectionMatrices.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_ConvectionMatrices_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_ConvectionMatrices_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_IterativeSolver.asv: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_IterativeSolver.asv -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_IterativeSolver.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_IterativeSolver.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_LocalDiffusionInPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_LocalDiffusionInPoints.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_Mapping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_Mapping.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_MappingProject.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_MappingProject.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_Mapping_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_Mapping_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_Mapping_auxDt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_Mapping_auxDt.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_Matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_Matrix.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_ParallDiffusionEnergyMatrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_ParallDiffusionEnergyMatrix.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_ParallDiffusionEnergyMatrix_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_ParallDiffusionEnergyMatrix_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_PostprocessMatrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_PostprocessMatrix.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_PostprocessSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_PostprocessSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_PrecalculatedConvectionTensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_PrecalculatedConvectionTensor.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_PrecalculatedMatrices.asv: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_PrecalculatedMatrices.asv -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_PrecalculatedMatrices.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_PrecalculatedMatrices.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_PrecalculatedMatrices3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_PrecalculatedMatrices3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_Preprocess.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_Preprocess.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_ShockCapturing.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_ShockCapturing.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_bc.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_bc.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_bc_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_bc_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_bc_3D_aux.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_bc_3D_aux.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/hdg_bc_3D_old.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/hdg_bc_3D_old.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/HDG/setPeriodicBoundary.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/HDG/setPeriodicBoundary.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/EigenvaluesJ.mw: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/EigenvaluesJ.mw -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/analyticalSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/analyticalSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/analyticalSolution_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/analyticalSolution_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf1_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf1_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf2.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf24.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf24.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf25.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf25.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf26.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf26.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf2_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf2_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf3.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf3.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf4.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf4.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf5.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf5.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bf6.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bf6.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bodyForce.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bodyForce.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bodyForce_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bodyForce_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bodyForce_3D_new.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bodyForce_3D_new.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/bodyForce_3D_old.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/bodyForce_3D_old.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/checkProblem.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/checkProblem.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/computeLocalDiffusionInPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/computeLocalDiffusionInPoints.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/cons2phys.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/cons2phys.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/defineMagneticField.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/defineMagneticField.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/defineMagneticField_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/defineMagneticField_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/initializeSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/initializeSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/initializeSolutionToAnalyticalSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/initializeSolutionToAnalyticalSol.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/initializeSolutionToAnalyticalSol_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/initializeSolutionToAnalyticalSol_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/initializeSolutionWithL2Projection.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/initializeSolutionWithL2Projection.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/loadMagneticField.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/loadMagneticField.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/rhsbohm.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/rhsbohm.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHD/setDirichletFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHD/setDirichletFaces.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHDG_NGammaTiTe.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHDG_NGammaTiTe.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/MHDG_NGammaTiTe3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/MHDG_NGammaTiTe3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/CreaMalla.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/CreaMalla.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/GenerateMatFileFromEZ4U.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/GenerateMatFileFromEZ4U.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/GetFaces_mod.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/GetFaces_mod.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/GetFaces_mod.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/GetFaces_mod.m~ -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/HDF5load.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/HDF5load.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/blendingboundary.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/blendingboundary.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/boundaryLayerProperties.asv: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/boundaryLayerProperties.asv -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/boundaryLayerProperties.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/boundaryLayerProperties.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/calculateElementByElementGradient.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/calculateElementByElementGradient.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/calculateL2ErrorTwoSolutionDifferentP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/calculateL2ErrorTwoSolutionDifferentP.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/calculateL2ErrorTwoSolutionDifferentP_scalar.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/calculateL2ErrorTwoSolutionDifferentP_scalar.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/calculateL2ErrorTwoSolutionNested.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/calculateL2ErrorTwoSolutionNested.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/checkMapping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/checkMapping.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/checksolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/checksolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/col.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/col.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/colt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/colt.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeErrorAnalyticSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeErrorAnalyticSol.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeErrorVelocity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeErrorVelocity.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeError_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeError_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeGradPerp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeGradPerp.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeImageHighOrderRepresentation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeImageHighOrderRepresentation.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeLiftDragTorque.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeLiftDragTorque.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeResiduals_global.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeResiduals_global.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeResiduals_global_alt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeResiduals_global_alt.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeResiduals_local.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeResiduals_local.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeResiduals_local_analiticalGrad.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeResiduals_local_analiticalGrad.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeResiduals_local_analiticalGrad_3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeResiduals_local_analiticalGrad_3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/computeSourceIntgral.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/computeSourceIntgral.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/converFortranSolutionToMatlab.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/converFortranSolutionToMatlab.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/createBackgroundMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/createBackgroundMesh.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/createContinuousSolution_scal.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/createContinuousSolution_scal.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/createContinuousSolution_vec.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/createContinuousSolution_vec.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/createCrossConnectivity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/createCrossConnectivity.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/createRuledConnectivity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/createRuledConnectivity.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/defineStartingPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/defineStartingPoints.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/export_fig.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/export_fig.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/extractFaceSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/extractFaceSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/extractFaceSolution_3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/extractFaceSolution_3d.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/findCoeffShockCaptur.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/findCoeffShockCaptur.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/findElementSize.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/findElementSize.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/findNegativeJacobians.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/findNegativeJacobians.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/findface.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/findface.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/firstElementLayer.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/firstElementLayer.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/fixDataWithRepeatedNodes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/fixDataWithRepeatedNodes.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/fixMeshWithRepeatedNodes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/fixMeshWithRepeatedNodes.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/fixMeshes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/fixMeshes.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/getEdge_tri.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/getEdge_tri.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/getHOcurve.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/getHOcurve.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/getHOcurve_preComputations.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/getHOcurve_preComputations.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/gmres_r.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/gmres_r.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/linearMapping.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/linearMapping.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/linearMappingQua.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/linearMappingQua.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/nElementLayer.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/nElementLayer.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotBoundary.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotBoundary.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotConstantElementalValue.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotConstantElementalValue.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotCp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotCp.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotCpOnAirfoil.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotCpOnAirfoil.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotDensityDiscontinuous.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotDensityDiscontinuous.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotDetachmentPoint.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotDetachmentPoint.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotDiamagDrift.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotDiamagDrift.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotDiscontinuousSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotDiscontinuousSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotError.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotError.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotErrorExactSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotErrorExactSol.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotErrorMap.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotErrorMap.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotErrorMap_new.asv: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotErrorMap_new.asv -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotErrorMap_new.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotErrorMap_new.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotFaceVelocity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotFaceVelocity.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotMesh.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotMesh_HOElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotMesh_HOElement.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotMesh_HOElement_mod.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotMesh_HOElement_mod.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotParallelVelocityDiscontinuous.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotParallelVelocityDiscontinuous.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotParallelVelocityVector.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotParallelVelocityVector.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotPressure.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotPressure.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotSkinFrictionCoeff.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotSkinFrictionCoeff.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotSolutionDifference.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotSolutionDifference.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotSolutionOnALine.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotSolutionOnALine.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotSolutionPhys.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotSolutionPhys.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotSourcesWest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotSourcesWest.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotStreamLines.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotStreamLines.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotStreamlinesWithStreamFunction.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotStreamlinesWithStreamFunction.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotVelocity.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotVelocity.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/HDGtoFineLinearApproximation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/HDGtoFineLinearApproximation.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/SoniaPostprocessExample2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/SoniaPostprocessExample2.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/computeShapeFunctionsAtPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/computeShapeFunctionsAtPoints.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/computeShapeFunctionsAtPointsQuads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/computeShapeFunctionsAtPointsQuads.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/evalDGapproximationAtPoints.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/evalDGapproximationAtPoints.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/findElementForx.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/findElementForx.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/fnonlinearInverseIsoTrans.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/fnonlinearInverseIsoTrans.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/inverseIsopTransf.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/inverseIsopTransf.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/inverseIsoparametricTransformation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/inverseIsoparametricTransformation.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/inverseLinearTransformation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/inverseLinearTransformation.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/inverseLinearTransformationQua.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/inverseLinearTransformationQua.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/isoparametricTransformationHighOrder.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/isoparametricTransformationHighOrder.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/isoparametricTransformationHighOrderQua.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/isoparametricTransformationHighOrderQua.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/testFindElementForx.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/testFindElementForx.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/plotroutine/testInverseIsoparametricTransformation.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/plotroutine/testInverseIsoparametricTransformation.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/postprocess_CircularCaseLimiter.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/postprocess_CircularCaseLimiter.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/print2eps.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/print2eps.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/projectFieldDifferentP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/projectFieldDifferentP.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/prolExp.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/prolExp.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/readMatTxt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/readMatTxt.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/readyforprintjpeg.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/readyforprintjpeg.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/readyforprintnew.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/readyforprintnew.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/rotationStructure.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/rotationStructure.mat -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/saveData.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/saveData.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/saveSolutionWithParametersName.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/saveSolutionWithParametersName.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/sawMeshes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/sawMeshes.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/setBoundarySquareMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/setBoundarySquareMesh.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/setNeumannFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/setNeumannFaces.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/setOrderLinearMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/setOrderLinearMesh.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/setperm.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/setperm.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/setperm3d.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/setperm3d.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/storeSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/storeSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/store_simulation_parameters.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/store_simulation_parameters.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/structCompare.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/structCompare.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/thwaites.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/thwaites.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/tricontour.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/tricontour.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/tryAnalyticalSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/tryAnalyticalSol.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/Utilities/using_hg2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/Utilities/using_hg2.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/auxplot_SolutionOnLline.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/auxplot_SolutionOnLline.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/auxplotconv.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/auxplotconv.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/checkMappingWest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/checkMappingWest.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/cleanBackupFiles.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/cleanBackupFiles.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/computeIntSol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/computeIntSol.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/convExpress2Fort.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/convExpress2Fort.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/convertMatrixCSRtoIJK.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/convertMatrixCSRtoIJK.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/debugFortran.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/debugFortran.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/expandMatrixA_mult.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/expandMatrixA_mult.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/expand_matrix.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/expand_matrix.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/extractSolutionInAtGivenTheta.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/extractSolutionInAtGivenTheta.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/filterSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/filterSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/filterSolutionElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/filterSolutionElement.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/fortrantest: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/fortrantest -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/ftest: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/ftest -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/impthr.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/impthr.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/loadData.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/loadData.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/magnetic_field_case60.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/magnetic_field_case60.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/GaussLegendreCubature2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/GaussLegendreCubature2D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/ProvaComputeShapeFunctionsReferenceElementQuads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/ProvaComputeShapeFunctionsReferenceElementQuads.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/Vandermonde_LP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/Vandermonde_LP.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/Vandermonde_LP2D_Quad.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/Vandermonde_LP2D_Quad.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/computeShapeFunctionsQua.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/computeShapeFunctionsQua.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/computeShapeFunctionsReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/computeShapeFunctionsReferenceElement.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/createReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/createReferenceElement.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/createShapeFunctions2dTensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/createShapeFunctions2dTensor.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/feketeNodes1D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/feketeNodes1D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/feketeNodesTri2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/feketeNodesTri2D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/gaussLegendre.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/gaussLegendre.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/getPermutationsQuads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/getPermutationsQuads.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/Vandermonde_LP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/Vandermonde_LP.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/jacobiPol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/jacobiPol.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/mapXiEtaZeta2rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/mapXiEtaZeta2rst.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly1D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly1D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly1D_deriv.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly1D_deriv.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly2D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly2D_deriv_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly2D_deriv_rst.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly2D_deriv_xieta.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly2D_deriv_xieta.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly2D_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly2D_rst.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly3D.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly3D_deriv_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly3D_deriv_rst.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly3D_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/orthopoly/orthopoly3D_rst.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/permutations_quads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/permutations_quads.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/matlabShapeFunctions/positionFeketeNodesTri2D_EZ4U.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/matlabShapeFunctions/positionFeketeNodesTri2D_EZ4U.mat -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/plotFortranSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/plotFortranSolution.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/plotFortranSolution_difference.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/plotFortranSolution_difference.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/plotFortranSolution_parallel.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/plotFortranSolution_parallel.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/plotTauOnFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/plotTauOnFaces.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/prova.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/prova.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/prova2.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/prova2.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/prova_eig.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/prova_eig.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/readCSRVectortxt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/readCSRVectortxt.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/readCSRVectortxtParall.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/readCSRVectortxtParall.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/readCSRtxt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/readCSRtxt.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/readCSRtxtParall.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/readCSRtxtParall.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/readMatTxt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/readMatTxt.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/setpath.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/setpath.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/symbEig.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/symbEig.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/symbEigBohm.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/symbEigBohm.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/symbEig_NGamma.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/symbEig_NGamma.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/symbRHSAnisoth.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/symbRHSAnisoth.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/test.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/test.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/testWest.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/testWest.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/testWestNew.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/testWestNew.m -------------------------------------------------------------------------------- /matlab/MHD_NGammaTiTe/testglo.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/MHD_NGammaTiTe/testglo.m -------------------------------------------------------------------------------- /matlab/Meshes/CircLimAlign_Quads_Nel208_P4.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/CircLimAlign_Quads_Nel208_P4.mat -------------------------------------------------------------------------------- /matlab/Meshes/Circle_LIM_InfThin_h0.1_RefCorn0.02_P4.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/Circle_LIM_InfThin_h0.1_RefCorn0.02_P4.mat -------------------------------------------------------------------------------- /matlab/Meshes/CreaMalla.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/CreaMalla.m -------------------------------------------------------------------------------- /matlab/Meshes/DomainDecomposition.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/DomainDecomposition.m -------------------------------------------------------------------------------- /matlab/Meshes/GenerateHDF5_meshes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/GenerateHDF5_meshes.m -------------------------------------------------------------------------------- /matlab/Meshes/GenerateHDF5_meshes_Parallel.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/GenerateHDF5_meshes_Parallel.m -------------------------------------------------------------------------------- /matlab/Meshes/GenerateHOMeshesCircGeomWithLim.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/GenerateHOMeshesCircGeomWithLim.m -------------------------------------------------------------------------------- /matlab/Meshes/GetFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/GetFaces.m -------------------------------------------------------------------------------- /matlab/Meshes/GetFaces_mod.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/GetFaces_mod.m -------------------------------------------------------------------------------- /matlab/Meshes/HDF5load.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/HDF5load.m -------------------------------------------------------------------------------- /matlab/Meshes/West_h0.04_refCorn_P4.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/West_h0.04_refCorn_P4.mat -------------------------------------------------------------------------------- /matlab/Meshes/convertMatMeshToHDF5.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/convertMatMeshToHDF5.m -------------------------------------------------------------------------------- /matlab/Meshes/findface.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/findface.m -------------------------------------------------------------------------------- /matlab/Meshes/linearMappingQua.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/linearMappingQua.m -------------------------------------------------------------------------------- /matlab/Meshes/sawMeshes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/sawMeshes.m -------------------------------------------------------------------------------- /matlab/Meshes/setBoundarySquareMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/setBoundarySquareMesh.m -------------------------------------------------------------------------------- /matlab/Meshes/setOrderLinearMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Meshes/setOrderLinearMesh.m -------------------------------------------------------------------------------- /matlab/Postprocess/FindCoefficients.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/FindCoefficients.m -------------------------------------------------------------------------------- /matlab/Postprocess/HDF5load.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/HDF5load.m -------------------------------------------------------------------------------- /matlab/Postprocess/checkDimensions.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/checkDimensions.m -------------------------------------------------------------------------------- /matlab/Postprocess/col.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/col.m -------------------------------------------------------------------------------- /matlab/Postprocess/colt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/colt.m -------------------------------------------------------------------------------- /matlab/Postprocess/cons2phys.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/cons2phys.m -------------------------------------------------------------------------------- /matlab/Postprocess/createReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/createReferenceElement.m -------------------------------------------------------------------------------- /matlab/Postprocess/extractSolutionInAtGivenTheta.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/extractSolutionInAtGivenTheta.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/GaussLegendreCubature2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/GaussLegendreCubature2D.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/Vandermonde_LP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/Vandermonde_LP.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/computeShapeFunctionsQua.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/computeShapeFunctionsQua.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/computeShapeFunctionsReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/computeShapeFunctionsReferenceElement.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/createReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/createReferenceElement.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/createShapeFunctions2dTensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/createShapeFunctions2dTensor.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/feketeNodes1D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/feketeNodes1D.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/feketeNodesTri2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/feketeNodesTri2D.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/gaussLegendre.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/gaussLegendre.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/getPermutationsQuads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/getPermutationsQuads.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/jacobiPol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/jacobiPol.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/mapXiEtaZeta2rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/mapXiEtaZeta2rst.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/orthopoly1D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/orthopoly1D.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/orthopoly1D_deriv.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/orthopoly1D_deriv.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/orthopoly2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/orthopoly2D.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/orthopoly2D_deriv_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/orthopoly2D_deriv_rst.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/orthopoly2D_deriv_xieta.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/orthopoly2D_deriv_xieta.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/orthopoly2D_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/orthopoly2D_rst.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/orthopoly3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/orthopoly3D.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/orthopoly3D_deriv_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/orthopoly3D_deriv_rst.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/orthopoly3D_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/orthopoly3D_rst.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/permutations_quads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/permutations_quads.m -------------------------------------------------------------------------------- /matlab/Postprocess/orthopoly/positionFeketeNodesTri2D_EZ4U.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/orthopoly/positionFeketeNodesTri2D_EZ4U.mat -------------------------------------------------------------------------------- /matlab/Postprocess/plotFortranSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/plotFortranSolution.m -------------------------------------------------------------------------------- /matlab/Postprocess/plotMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/plotMesh.m -------------------------------------------------------------------------------- /matlab/Postprocess/plotSolution.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/plotSolution.m -------------------------------------------------------------------------------- /matlab/Postprocess/prova.m: -------------------------------------------------------------------------------- 1 | function prova 2 | 3 | a.b.c.d = 1; 4 | assignin('caller','a',a) -------------------------------------------------------------------------------- /matlab/Postprocess/readyforprintjpeg.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/readyforprintjpeg.m -------------------------------------------------------------------------------- /matlab/Postprocess/readyforprintnew.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/readyforprintnew.m -------------------------------------------------------------------------------- /matlab/Postprocess/setpath.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Postprocess/setpath.m -------------------------------------------------------------------------------- /matlab/Preprocess/CreaMalla.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/CreaMalla.m -------------------------------------------------------------------------------- /matlab/Preprocess/DomainDecomposition.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/DomainDecomposition.m -------------------------------------------------------------------------------- /matlab/Preprocess/DomainDecomposition.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/DomainDecomposition.m~ -------------------------------------------------------------------------------- /matlab/Preprocess/FindCoefficients.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/FindCoefficients.m -------------------------------------------------------------------------------- /matlab/Preprocess/GenerateHDF5_meshes_Parallel.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/GenerateHDF5_meshes_Parallel.m -------------------------------------------------------------------------------- /matlab/Preprocess/GenerateHOMeshesCircGeomWithLim.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/GenerateHOMeshesCircGeomWithLim.m -------------------------------------------------------------------------------- /matlab/Preprocess/GetFaces.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/GetFaces.m -------------------------------------------------------------------------------- /matlab/Preprocess/GetFaces_mod.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/GetFaces_mod.m -------------------------------------------------------------------------------- /matlab/Preprocess/HDF5load.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/HDF5load.m -------------------------------------------------------------------------------- /matlab/Preprocess/checkDimensions.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/checkDimensions.m -------------------------------------------------------------------------------- /matlab/Preprocess/col.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/col.m -------------------------------------------------------------------------------- /matlab/Preprocess/colt.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/colt.m -------------------------------------------------------------------------------- /matlab/Preprocess/compute_balance.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/compute_balance.m -------------------------------------------------------------------------------- /matlab/Preprocess/compute_balance_it.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/compute_balance_it.m -------------------------------------------------------------------------------- /matlab/Preprocess/compute_balance_it.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/compute_balance_it.m~ -------------------------------------------------------------------------------- /matlab/Preprocess/convertMatMeshToHDF5.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/convertMatMeshToHDF5.m -------------------------------------------------------------------------------- /matlab/Preprocess/createReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/createReferenceElement.m -------------------------------------------------------------------------------- /matlab/Preprocess/extractSolutionInAtGivenTheta.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/extractSolutionInAtGivenTheta.m -------------------------------------------------------------------------------- /matlab/Preprocess/findface.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/findface.m -------------------------------------------------------------------------------- /matlab/Preprocess/linearMappingQua.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/linearMappingQua.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/GaussLegendreCubature2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/GaussLegendreCubature2D.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/Vandermonde_LP.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/Vandermonde_LP.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/computeShapeFunctionsQua.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/computeShapeFunctionsQua.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/computeShapeFunctionsReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/computeShapeFunctionsReferenceElement.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/createReferenceElement.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/createReferenceElement.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/createShapeFunctions2dTensor.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/createShapeFunctions2dTensor.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/feketeNodes1D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/feketeNodes1D.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/feketeNodesTri2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/feketeNodesTri2D.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/gaussLegendre.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/gaussLegendre.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/getPermutationsQuads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/getPermutationsQuads.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/jacobiPol.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/jacobiPol.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/mapXiEtaZeta2rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/mapXiEtaZeta2rst.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/orthopoly1D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/orthopoly1D.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/orthopoly1D_deriv.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/orthopoly1D_deriv.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/orthopoly2D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/orthopoly2D.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/orthopoly2D_deriv_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/orthopoly2D_deriv_rst.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/orthopoly2D_deriv_xieta.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/orthopoly2D_deriv_xieta.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/orthopoly2D_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/orthopoly2D_rst.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/orthopoly3D.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/orthopoly3D.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/orthopoly3D_deriv_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/orthopoly3D_deriv_rst.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/orthopoly3D_rst.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/orthopoly3D_rst.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/permutations_quads.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/permutations_quads.m -------------------------------------------------------------------------------- /matlab/Preprocess/orthopoly/positionFeketeNodesTri2D_EZ4U.mat: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/orthopoly/positionFeketeNodesTri2D_EZ4U.mat -------------------------------------------------------------------------------- /matlab/Preprocess/plotFortranSolution.m~: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/plotFortranSolution.m~ -------------------------------------------------------------------------------- /matlab/Preprocess/plotMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/plotMesh.m -------------------------------------------------------------------------------- /matlab/Preprocess/sawMeshes.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/sawMeshes.m -------------------------------------------------------------------------------- /matlab/Preprocess/setBoundarySquareMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/setBoundarySquareMesh.m -------------------------------------------------------------------------------- /matlab/Preprocess/setOrderLinearMesh.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/setOrderLinearMesh.m -------------------------------------------------------------------------------- /matlab/Preprocess/setpath.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/matlab/Preprocess/setpath.m -------------------------------------------------------------------------------- /src/Convergence.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Convergence.f90 -------------------------------------------------------------------------------- /src/Definitions/globals.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Definitions/globals.f90 -------------------------------------------------------------------------------- /src/Definitions/prec_const.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Definitions/prec_const.f90 -------------------------------------------------------------------------------- /src/Definitions/types.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Definitions/types.f90 -------------------------------------------------------------------------------- /src/HDG/compute_element_solution.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/compute_element_solution.f90 -------------------------------------------------------------------------------- /src/HDG/hdg_Assembly.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/hdg_Assembly.f90 -------------------------------------------------------------------------------- /src/HDG/hdg_BC.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/hdg_BC.f90 -------------------------------------------------------------------------------- /src/HDG/hdg_ComputeJacobian.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/hdg_ComputeJacobian.f90 -------------------------------------------------------------------------------- /src/HDG/hdg_LimitingTechniques.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/hdg_LimitingTechniques.f90 -------------------------------------------------------------------------------- /src/HDG/hdg_Mapping.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/hdg_Mapping.f90 -------------------------------------------------------------------------------- /src/HDG/hdg_PrecalculatedFirstEquation.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/hdg_PrecalculatedFirstEquation.f90 -------------------------------------------------------------------------------- /src/HDG/initialization.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/initialization.f90 -------------------------------------------------------------------------------- /src/HDG/preprocess.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/preprocess.f90 -------------------------------------------------------------------------------- /src/HDG/reference_element.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/reference_element.f90 -------------------------------------------------------------------------------- /src/HDG/solve_global_system.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/HDG/solve_global_system.f90 -------------------------------------------------------------------------------- /src/InOut/HDF5_io.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/InOut/HDF5_io.f90 -------------------------------------------------------------------------------- /src/InOut/Postprocess.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/InOut/Postprocess.f90 -------------------------------------------------------------------------------- /src/InOut/inout.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/InOut/inout.f90 -------------------------------------------------------------------------------- /src/InOut/prova.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/InOut/prova.f90 -------------------------------------------------------------------------------- /src/InOut/read_input.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/InOut/read_input.f90 -------------------------------------------------------------------------------- /src/LinearAlgebra/LinearAlgebra.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/LinearAlgebra/LinearAlgebra.f90 -------------------------------------------------------------------------------- /src/LinearAlgebra/interpolation.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/LinearAlgebra/interpolation.f90 -------------------------------------------------------------------------------- /src/LinearAlgebra/matrices_tools.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/LinearAlgebra/matrices_tools.f90 -------------------------------------------------------------------------------- /src/LinearAlgebra/matrices_types.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/LinearAlgebra/matrices_types.f90 -------------------------------------------------------------------------------- /src/LinearAlgebra/solve_pastix.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/LinearAlgebra/solve_pastix.f90 -------------------------------------------------------------------------------- /src/LinearAlgebra/solve_psblas.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/LinearAlgebra/solve_psblas.f90 -------------------------------------------------------------------------------- /src/MHDG.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/MHDG.f90 -------------------------------------------------------------------------------- /src/MPI_OMP/Communications.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/MPI_OMP/Communications.f90 -------------------------------------------------------------------------------- /src/MPI_OMP/MPI_OMP.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/MPI_OMP/MPI_OMP.f90 -------------------------------------------------------------------------------- /src/Models/Laplace/analytical.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/Laplace/analytical.f90 -------------------------------------------------------------------------------- /src/Models/Laplace/physics.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/Laplace/physics.f90 -------------------------------------------------------------------------------- /src/Models/NGamma/analytical.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/NGamma/analytical.f90 -------------------------------------------------------------------------------- /src/Models/NGamma/physics.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/NGamma/physics.f90 -------------------------------------------------------------------------------- /src/Models/NGammaLaplace/analytical.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/NGammaLaplace/analytical.f90 -------------------------------------------------------------------------------- /src/Models/NGammaLaplace/physics.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/NGammaLaplace/physics.f90 -------------------------------------------------------------------------------- /src/Models/NGammaTiTe/analytical.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/NGammaTiTe/analytical.f90 -------------------------------------------------------------------------------- /src/Models/NGammaTiTe/physics.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/NGammaTiTe/physics.f90 -------------------------------------------------------------------------------- /src/Models/NGammaVort/analytical.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/NGammaVort/analytical.f90 -------------------------------------------------------------------------------- /src/Models/NGammaVort/physics.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/NGammaVort/physics.f90 -------------------------------------------------------------------------------- /src/Models/adimensionalization.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/adimensionalization.f90 -------------------------------------------------------------------------------- /src/Models/magnetic_field.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Models/magnetic_field.f90 -------------------------------------------------------------------------------- /src/Utils/Debug.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Utils/Debug.f90 -------------------------------------------------------------------------------- /src/Utils/PrintUtils.f90: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/src/Utils/PrintUtils.f90 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_1_4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_1_4.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_1_8.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_1_8.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_2_4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_2_4.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_2_8.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_2_8.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_3_4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_3_4.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_3_8.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_3_8.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_4_4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_4_4.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_4_8.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_4_8.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_5_8.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_5_8.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_6_8.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_6_8.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_7_8.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_7_8.h5 -------------------------------------------------------------------------------- /test/CircLimAlign_Quads_Nel208_P4_8_8.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/CircLimAlign_Quads_Nel208_P4_8_8.h5 -------------------------------------------------------------------------------- /test/Square_1_P1.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_1_P1.h5 -------------------------------------------------------------------------------- /test/Square_1_P2.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_1_P2.h5 -------------------------------------------------------------------------------- /test/Square_1_P3.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_1_P3.h5 -------------------------------------------------------------------------------- /test/Square_1_P4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_1_P4.h5 -------------------------------------------------------------------------------- /test/Square_1_P5.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_1_P5.h5 -------------------------------------------------------------------------------- /test/Square_2_P1.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_2_P1.h5 -------------------------------------------------------------------------------- /test/Square_2_P2.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_2_P2.h5 -------------------------------------------------------------------------------- /test/Square_2_P3.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_2_P3.h5 -------------------------------------------------------------------------------- /test/Square_2_P4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_2_P4.h5 -------------------------------------------------------------------------------- /test/Square_2_P5.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_2_P5.h5 -------------------------------------------------------------------------------- /test/Square_3_P1.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_3_P1.h5 -------------------------------------------------------------------------------- /test/Square_3_P2.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_3_P2.h5 -------------------------------------------------------------------------------- /test/Square_3_P3.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_3_P3.h5 -------------------------------------------------------------------------------- /test/Square_3_P4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_3_P4.h5 -------------------------------------------------------------------------------- /test/Square_3_P5.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_3_P5.h5 -------------------------------------------------------------------------------- /test/Square_4_P1.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_4_P1.h5 -------------------------------------------------------------------------------- /test/Square_4_P2.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_4_P2.h5 -------------------------------------------------------------------------------- /test/Square_4_P3.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_4_P3.h5 -------------------------------------------------------------------------------- /test/Square_4_P4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_4_P4.h5 -------------------------------------------------------------------------------- /test/Square_4_P5.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_4_P5.h5 -------------------------------------------------------------------------------- /test/Square_5_P1.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_5_P1.h5 -------------------------------------------------------------------------------- /test/Square_5_P2.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_5_P2.h5 -------------------------------------------------------------------------------- /test/Square_5_P3.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_5_P3.h5 -------------------------------------------------------------------------------- /test/Square_5_P4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_5_P4.h5 -------------------------------------------------------------------------------- /test/Square_5_P5.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_5_P5.h5 -------------------------------------------------------------------------------- /test/Square_6_P1.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_6_P1.h5 -------------------------------------------------------------------------------- /test/Square_6_P2.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_6_P2.h5 -------------------------------------------------------------------------------- /test/Square_6_P3.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_6_P3.h5 -------------------------------------------------------------------------------- /test/Square_6_P4.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_6_P4.h5 -------------------------------------------------------------------------------- /test/Square_6_P5.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/Square_6_P5.h5 -------------------------------------------------------------------------------- /test/param.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/param.txt -------------------------------------------------------------------------------- /test/positionFeketeNodesTri2D.h5: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/positionFeketeNodesTri2D.h5 -------------------------------------------------------------------------------- /test/prova: -------------------------------------------------------------------------------- 1 | 2 | -------------------------------------------------------------------------------- /test/setPerpDiff.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/giorgianig/MHDG/HEAD/test/setPerpDiff.sh --------------------------------------------------------------------------------