Index: head/science/Makefile =================================================================== --- head/science/Makefile (revision 425892) +++ head/science/Makefile (revision 425893) @@ -1,190 +1,191 @@ # $FreeBSD$ # COMMENT = Scientific ports SUBDIR += 2d-rewriter SUBDIR += InsightToolkit SUBDIR += R-cran-AMORE SUBDIR += R-cran-DCluster SUBDIR += R-cran-Epi SUBDIR += R-cran-bayesm SUBDIR += R-cran-cmprsk SUBDIR += R-cran-e1071 SUBDIR += R-cran-eco SUBDIR += R-cran-epicalc SUBDIR += R-cran-etm SUBDIR += R-cran-snow SUBDIR += R-cran-som SUBDIR += afni SUBDIR += avogadro SUBDIR += bddsolve SUBDIR += bft SUBDIR += bodr SUBDIR += brian SUBDIR += buddy SUBDIR += cdcl SUBDIR += cdf SUBDIR += cdo SUBDIR += cgnslib SUBDIR += cgribex SUBDIR += checkmol SUBDIR += chemical-mime-data SUBDIR += chemtool SUBDIR += chemtool-devel SUBDIR += clhep SUBDIR += colt SUBDIR += crf++ SUBDIR += dcl SUBDIR += devisor SUBDIR += dlpoly-classic SUBDIR += ecs SUBDIR += epte SUBDIR += fastcap SUBDIR += fasthenry SUBDIR += fisicalab SUBDIR += fvcom SUBDIR += fvcom-mpi SUBDIR += fvm SUBDIR += gchemutils SUBDIR += getdp SUBDIR += ghemical SUBDIR += ghmm SUBDIR += gnudatalanguage SUBDIR += gramps SUBDIR += grib_api SUBDIR += gromacs SUBDIR += gsmc SUBDIR += gtamsanalyzer SUBDIR += gwyddion SUBDIR += h5utils SUBDIR += harminv SUBDIR += hdf SUBDIR += hdf5 SUBDIR += hs-bio SUBDIR += isaac-cfd SUBDIR += jstrack SUBDIR += kalzium SUBDIR += kst2 SUBDIR += lamprop SUBDIR += libctl SUBDIR += libghemical SUBDIR += libint SUBDIR += libkml SUBDIR += liblinear SUBDIR += liboglappth SUBDIR += libquantum SUBDIR += libsvm SUBDIR += libsvm-python SUBDIR += libxc SUBDIR += linsmith SUBDIR += massxpert SUBDIR += mbdyn SUBDIR += mcstas SUBDIR += mcstas-comps SUBDIR += medit SUBDIR += meep SUBDIR += mei SUBDIR += metaf2xml SUBDIR += minc2 SUBDIR += mol2ps SUBDIR += mpb SUBDIR += mpqc SUBDIR += mpqc-mpich SUBDIR += ncs SUBDIR += netcdf SUBDIR += netcdf-cxx SUBDIR += netcdf-fortran SUBDIR += nifticlib SUBDIR += openbabel SUBDIR += openkim SUBDIR += orthanc SUBDIR += orthanc-dicomweb SUBDIR += orthanc-postgresql SUBDIR += orthanc-webviewer SUBDIR += p5-Algorithm-SVMLight SUBDIR += p5-Chemistry-3DBuilder SUBDIR += p5-Chemistry-Bond-Find SUBDIR += p5-Chemistry-Canonicalize SUBDIR += p5-Chemistry-Elements SUBDIR += p5-Chemistry-File-MDLMol SUBDIR += p5-Chemistry-File-Mopac SUBDIR += p5-Chemistry-File-PDB SUBDIR += p5-Chemistry-File-SLN SUBDIR += p5-Chemistry-File-SMARTS SUBDIR += p5-Chemistry-File-SMILES SUBDIR += p5-Chemistry-File-VRML SUBDIR += p5-Chemistry-File-XYZ SUBDIR += p5-Chemistry-FormulaPattern SUBDIR += p5-Chemistry-InternalCoords SUBDIR += p5-Chemistry-Isotope SUBDIR += p5-Chemistry-MacroMol SUBDIR += p5-Chemistry-MidasPattern SUBDIR += p5-Chemistry-Mok SUBDIR += p5-Chemistry-Mol SUBDIR += p5-Chemistry-Pattern SUBDIR += p5-Chemistry-Reaction SUBDIR += p5-Chemistry-Ring SUBDIR += p5-Geo-BUFR SUBDIR += p5-Geo-Coordinates-Converter SUBDIR += p5-Geo-Coordinates-Converter-iArea SUBDIR += p5-Geo-ReadGRIB SUBDIR += p5-Geo-WebService-Elevation-USGS SUBDIR += p5-Mcstas-Tools SUBDIR += p5-PerlMol SUBDIR += p5-Physics-Unit SUBDIR += paje SUBDIR += paraview SUBDIR += pnetcdf SUBDIR += psychopy SUBDIR += pulseview SUBDIR += py-DendroPy SUBDIR += py-cdo SUBDIR += py-coards SUBDIR += py-h5py SUBDIR += py-hcluster SUBDIR += py-mdp SUBDIR += py-mlpy SUBDIR += py-netCDF4 SUBDIR += py-obspy SUBDIR += py-paida SUBDIR += py-pupynere SUBDIR += py-pyaixi SUBDIR += py-pydicom SUBDIR += py-pysal SUBDIR += py-pyteomics SUBDIR += py-pyteomics.biolccc SUBDIR += py-scikit-fuzzy SUBDIR += py-scikit-learn SUBDIR += py-scikit-sparse SUBDIR += py-scimath SUBDIR += py-scipy SUBDIR += py-ws2300 SUBDIR += pybrain SUBDIR += pycdf SUBDIR += pynn SUBDIR += qcl SUBDIR += qtresistors SUBDIR += rubygem-ai4r SUBDIR += rubygem-cdo SUBDIR += rubygem-ruby-dcl SUBDIR += rubygem-ruby-netcdf SUBDIR += sigrok-cli SUBDIR += sigrok-firmware SUBDIR += sigrok-firmware-fx2lafw SUBDIR += sigrok-firmware-utils SUBDIR += silo SUBDIR += simlib SUBDIR += simsmith SUBDIR += step SUBDIR += svmlight SUBDIR += szip + SUBDIR += tfel SUBDIR += udunits SUBDIR += v_sim SUBDIR += veusz SUBDIR += vmd SUBDIR += voro++ SUBDIR += xfce4-equake-plugin SUBDIR += xmakemol .include Index: head/science/tfel/Makefile =================================================================== --- head/science/tfel/Makefile (nonexistent) +++ head/science/tfel/Makefile (revision 425893) @@ -0,0 +1,30 @@ +# Created by: Pedro F. Giffuni +# $FreeBSD$ + +PORTNAME= tfel +PORTVERSION= 2.0.3 +CATEGORIES= science +MASTER_SITES= SF/${PORTNAME}/ +PKGNAMESUFFIX= -mfront + +MAINTAINER= pfg@FreeBSD.org +COMMENT= Code generation tool dedicated to material knowledge + +LICENSE= GPLv3 + +OPTIONS_DEFINE= GNUPLOT +OPTIONS_DEFAULT= GNUPLOT +GNUPLOT_BUILD_DEPENDS= gnuplot:math/gnuplot +GNUPLOT_RUN_DEPENDS= gnuplot:math/gnuplot + +ONLY_FOR_ARCHS= amd64 i386 + +USES= autoreconf libtool tar:bzip2 +GNU_CONFIGURE=yes +CONFIGURE_ARGS= --enable-aster +USE_LDCONFIG= yes + +INSTALL_TARGET= install-strip +TEST_TARGET= check + +.include Property changes on: head/science/tfel/Makefile ___________________________________________________________________ Added: svn:eol-style ## -0,0 +1 ## +native \ No newline at end of property Added: svn:keywords ## -0,0 +1 ## +FreeBSD=%H \ No newline at end of property Added: svn:mime-type ## -0,0 +1 ## +text/plain \ No newline at end of property Index: head/science/tfel/distinfo =================================================================== --- head/science/tfel/distinfo (nonexistent) +++ head/science/tfel/distinfo (revision 425893) @@ -0,0 +1,3 @@ +TIMESTAMP = 1472936809 +SHA256 (tfel-2.0.3.tar.bz2) = 8f0020fd22d6f0e39d512e2aeb457bc5b6ad96bd66336d590bf433d9648f8a58 +SIZE (tfel-2.0.3.tar.bz2) = 50837415 Property changes on: head/science/tfel/distinfo ___________________________________________________________________ Added: fbsd:nokeywords ## -0,0 +1 ## +on \ No newline at end of property Added: svn:eol-style ## -0,0 +1 ## +native \ No newline at end of property Added: svn:mime-type ## -0,0 +1 ## +text/plain \ No newline at end of property Index: head/science/tfel/files/patch-configure.ac =================================================================== --- head/science/tfel/files/patch-configure.ac (nonexistent) +++ head/science/tfel/files/patch-configure.ac (revision 425893) @@ -0,0 +1,12 @@ +--- configure.ac.orig 2016-09-04 19:29:53 UTC ++++ configure.ac +@@ -69,6 +69,9 @@ case $host in + TFEL_ARCH32="yes" + ;; + # machine amd opteron, 64 bits ++ amd64*bsd*) ++ TFEL_ARCH64="yes" ++ ;; + x86_64*bsd*) + TFEL_ARCH64="yes" + ;; Property changes on: head/science/tfel/files/patch-configure.ac ___________________________________________________________________ Added: fbsd:nokeywords ## -0,0 +1 ## +on \ No newline at end of property Added: svn:eol-style ## -0,0 +1 ## +native \ No newline at end of property Added: svn:mime-type ## -0,0 +1 ## +text/plain \ No newline at end of property Index: head/science/tfel/pkg-descr =================================================================== --- head/science/tfel/pkg-descr (nonexistent) +++ head/science/tfel/pkg-descr (revision 425893) @@ -0,0 +1,21 @@ +`MFront` is a code generator which translates a set of closely related +domain specific languages into plain C++ on top of the `TFEL` +library. Those languages covers three kind of material knowledge: + +- material properties (for instance the + Young modulus, the thermal conductivity, etc.) +- mechanical behaviours. Numerical performances of + generated mechanical behaviours was given a particular + attention. Various benchmarks shows that `MFront` + implementations are competitive with native implementations + available in the `Cast3M`, `Code-Aster` and `Cyrano3` solvers. +- simple point-wise models, such as material swelling + used in fuel performance codes. + +`MFront` comes with an handy easy-to-use tool called `MTest` that can +test the local behaviour of a material, by imposing independent +constraints on each component of the strain or the stress. This tool +has been much faster (from ten to several hundred times depending on +the test case) than using a full-fledged finite element solver. + +WWW: http://tfel.sourceforge.net/ Property changes on: head/science/tfel/pkg-descr ___________________________________________________________________ Added: fbsd:nokeywords ## -0,0 +1 ## +on \ No newline at end of property Added: svn:eol-style ## -0,0 +1 ## +native \ No newline at end of property Added: svn:mime-type ## -0,0 +1 ## +text/plain \ No newline at end of property Index: head/science/tfel/pkg-plist =================================================================== --- head/science/tfel/pkg-plist (nonexistent) +++ head/science/tfel/pkg-plist (revision 425893) @@ -0,0 +1,882 @@ +bin/mfront +bin/mtest +bin/tfel-config +bin/tfel-doc +include/MFront/Aster/Aster.hxx +include/MFront/Aster/AsterBehaviourHandler.hxx +include/MFront/Aster/AsterComputeStiffnessTensor.hxx +include/MFront/Aster/AsterComputeThermalExpansionCoefficientTensor.hxx +include/MFront/Aster/AsterConfig.hxx +include/MFront/Aster/AsterException.hxx +include/MFront/Aster/AsterFiniteStrainRotationMatrix.hxx +include/MFront/Aster/AsterInterface.hxx +include/MFront/Aster/AsterInterfaceBase.hxx +include/MFront/Aster/AsterIsotropicBehaviourHandler.hxx +include/MFront/Aster/AsterOrthotropicBehaviour.hxx +include/MFront/Aster/AsterOrthotropicBehaviourHandler.hxx +include/MFront/Aster/AsterRotationMatrix.hxx +include/MFront/Aster/AsterStressFreeExpansionHandler.hxx +include/MFront/Aster/AsterTangentOperator.hxx +include/MFront/Aster/AsterTraits.hxx +include/MFront/BoundsDescription.hxx +include/MFront/CodeBlock.hxx +include/MFront/DrivingVariable.hxx +include/MFront/InterfaceBase.hxx +include/MFront/LawFunction.hxx +include/MFront/MFront.hxx +include/MFront/MFrontAsterInterface.hxx +include/MFront/MFrontBehaviourAnalyser.hxx +include/MFront/MFrontBehaviourAnalyserFactory.hxx +include/MFront/MFrontBehaviourAnalyserProxy.hxx +include/MFront/MFrontBehaviourAnalyserProxy.ixx +include/MFront/MFrontBehaviourInterfaceFactory.hxx +include/MFront/MFrontBehaviourInterfaceProxy.hxx +include/MFront/MFrontBehaviourInterfaceProxy.ixx +include/MFront/MFrontBehaviourParserBase.hxx +include/MFront/MFrontBehaviourParserBase.ixx +include/MFront/MFrontBehaviourParserCommon.hxx +include/MFront/MFrontBehaviourParserCommon.ixx +include/MFront/MFrontBehaviourProfiler.hxx +include/MFront/MFrontBehaviourVirtualInterface.hxx +include/MFront/MFrontConfig.hxx +include/MFront/MFrontDebugMode.hxx +include/MFront/MFrontDefaultCZMParser.hxx +include/MFront/MFrontDefaultFiniteStrainParser.hxx +include/MFront/MFrontDefaultParser.hxx +include/MFront/MFrontDefaultParserBase.hxx +include/MFront/MFrontFileDescription.hxx +include/MFront/MFrontGenericData.hxx +include/MFront/MFrontHeader.hxx +include/MFront/MFrontInitAnalysers.hxx +include/MFront/MFrontInitInterfaces.hxx +include/MFront/MFrontInitParsers.hxx +include/MFront/MFrontLawInterfaceFactory.hxx +include/MFront/MFrontLawInterfaceProxy.hxx +include/MFront/MFrontLawInterfaceProxy.ixx +include/MFront/MFrontLawVirtualInterface.hxx +include/MFront/MFrontLock.hxx +include/MFront/MFrontLogStream.hxx +include/MFront/MFrontMaterialLawParser.hxx +include/MFront/MFrontModelData.hxx +include/MFront/MFrontModelInterfaceFactory.hxx +include/MFront/MFrontModelInterfaceProxy.hxx +include/MFront/MFrontModelInterfaceProxy.ixx +include/MFront/MFrontModelParser.hxx +include/MFront/MFrontModelParserBase.hxx +include/MFront/MFrontModelParserBase.ixx +include/MFront/MFrontModelParserCommon.hxx +include/MFront/MFrontModelVirtualInterface.hxx +include/MFront/MFrontParserFactory.hxx +include/MFront/MFrontParserProxy.hxx +include/MFront/MFrontParserProxy.ixx +include/MFront/MFrontPedanticMode.hxx +include/MFront/MFrontPerformanceProfiling.hxx +include/MFront/MFrontSearchFile.hxx +include/MFront/MFrontUMATInterfaceBase.hxx +include/MFront/MFrontVirtualParser.hxx +include/MFront/MTest.hxx +include/MFront/MTestAccelerationAlgorithm.hxx +include/MFront/MTestAccelerationAlgorithmFactory.hxx +include/MFront/MTestAnalyticalTest.hxx +include/MFront/MTestAsterCohesiveZoneModel.hxx +include/MFront/MTestAsterFiniteStrainBehaviour.hxx +include/MFront/MTestAsterSmallStrainBehaviour.hxx +include/MFront/MTestAsterStandardBehaviour.hxx +include/MFront/MTestBehaviour.hxx +include/MFront/MTestCastemAccelerationAlgorithm.hxx +include/MFront/MTestCastemEvolution.hxx +include/MFront/MTestConfig.hxx +include/MFront/MTestConstraint.hxx +include/MFront/MTestCyranoBehaviour.hxx +include/MFront/MTestEvolution.hxx +include/MFront/MTestFileGeneratorBase.hxx +include/MFront/MTestFunctionEvolution.hxx +include/MFront/MTestImposedDrivingVariable.hxx +include/MFront/MTestImposedThermodynamicForce.hxx +include/MFront/MTestIronsTuckAccelerationAlgorithm.hxx +include/MFront/MTestParser.hxx +include/MFront/MTestReferenceFileComparisonTest.hxx +include/MFront/MTestSecantAccelerationAlgorithm.hxx +include/MFront/MTestSteffensenAccelerationAlgorithm.hxx +include/MFront/MTestTypes.hxx +include/MFront/MTestUmatBehaviourBase.hxx +include/MFront/MTestUmatCohesiveZoneModel.hxx +include/MFront/MTestUmatFiniteStrainBehaviour.hxx +include/MFront/MTestUmatNormaliseTangentOperator.hxx +include/MFront/MTestUmatSmallStrainBehaviour.hxx +include/MFront/MTestUmatStandardBehaviour.hxx +include/MFront/MaterialPropertyDescription.hxx +include/MFront/MechanicalBehaviourAttribute.hxx +include/MFront/MechanicalBehaviourData.hxx +include/MFront/MechanicalBehaviourData.ixx +include/MFront/MechanicalBehaviourDescription.hxx +include/MFront/MechanicalBehaviourDescription.ixx +include/MFront/MechanicalBehaviourSymmetryType.hxx +include/MFront/ParserBase.hxx +include/MFront/ParserBase.ixx +include/MFront/ParserUtilities.hxx +include/MFront/StaticVarHandler.hxx +include/MFront/StaticVariableDescription.hxx +include/MFront/SupportedTypes.hxx +include/MFront/ThermodynamicForce.hxx +include/MFront/UMATFiniteStrainMTestFileGenerator.hxx +include/MFront/UMATSmallStrainMTestFileGenerator.hxx +include/MFront/VarHandler.hxx +include/MFront/VariableBoundsDescription.hxx +include/MFront/VariableDescription.hxx +include/TFEL/Config/Internals/HeatFluxVectorType.hxx +include/TFEL/Config/Internals/InvJacobianType.hxx +include/TFEL/Config/Internals/JacobianType.hxx +include/TFEL/Config/Internals/PositionType.hxx +include/TFEL/Config/Internals/SpatialGradType.hxx +include/TFEL/Config/Internals/TFELTypesInternals.hxx +include/TFEL/Config/Internals/ThermalConductivityMatrixType.hxx +include/TFEL/Config/TFELConfig.hxx +include/TFEL/Config/TFELTypes.hxx +include/TFEL/Config/TFEL_MATH_Config.hxx +include/TFEL/Exception/TFELException.hxx +include/TFEL/FSAlgorithm/FSAlgorithm.hxx +include/TFEL/FSAlgorithm/accumulate.hxx +include/TFEL/FSAlgorithm/copy.hxx +include/TFEL/FSAlgorithm/equal.hxx +include/TFEL/FSAlgorithm/fill.hxx +include/TFEL/FSAlgorithm/for_each.hxx +include/TFEL/FSAlgorithm/generate.hxx +include/TFEL/FSAlgorithm/inner_product.hxx +include/TFEL/FSAlgorithm/iota.hxx +include/TFEL/FSAlgorithm/max_element.hxx +include/TFEL/FSAlgorithm/min_element.hxx +include/TFEL/FSAlgorithm/swap_ranges.hxx +include/TFEL/FSAlgorithm/transform.hxx +include/TFEL/Glossary/Forward/Glossary.hxx +include/TFEL/Glossary/Glossary.hxx +include/TFEL/Glossary/GlossaryEntry.hxx +include/TFEL/Macros.hxx +include/TFEL/Material/BoundsCheck.hxx +include/TFEL/Material/DDIF2Base.hxx +include/TFEL/Material/DDIF2Base.ixx +include/TFEL/Material/FiniteStrainBehaviourTangentOperator.hxx +include/TFEL/Material/FiniteStrainBehaviourTangentOperatorBase.hxx +include/TFEL/Material/GursonTvergaardNeedleman.hxx +include/TFEL/Material/Hill.hxx +include/TFEL/Material/Hill.ixx +include/TFEL/Material/IsotropicLinearFourierHookLaw.hxx +include/TFEL/Material/IsotropicLinearFourierLaw.hxx +include/TFEL/Material/Lame.hxx +include/TFEL/Material/MaterialException.hxx +include/TFEL/Material/MechanicalBehaviour.hxx +include/TFEL/Material/MechanicalBehaviourTraits.hxx +include/TFEL/Material/MetallicCFCGenericSlidingSystemsInteractionMatrix.hxx +include/TFEL/Material/MetallicCFCGenericSlidingSystemsInteractionMatrix.ixx +include/TFEL/Material/MetallicCFCSlidingSystems.hxx +include/TFEL/Material/MetallicCFCSlidingSystems.ixx +include/TFEL/Material/ModellingHypothesis.hxx +include/TFEL/Material/OutOfBoundsPolicy.hxx +include/TFEL/Material/PolyCrystalsSlidingSystems.hxx +include/TFEL/Material/PolyCrystalsSlidingSystems.ixx +include/TFEL/Material/RambergOsgood.hxx +include/TFEL/Material/ThermalBehaviour.hxx +include/TFEL/Material/ThermalBehaviourData.hxx +include/TFEL/Material/ThermoMechanicalBehaviour.hxx +include/TFEL/Math/Array/ArrayConcept.hxx +include/TFEL/Math/Array/ArrayConcept.ixx +include/TFEL/Math/Array/ArrayConceptOperations.hxx +include/TFEL/Math/Array/ArrayExpr.hxx +include/TFEL/Math/Array/ArrayRefCountedStorage.hxx +include/TFEL/Math/Array/ArrayRowMajorStorage.hxx +include/TFEL/Math/Array/ArrayRowMajorStorage.ixx +include/TFEL/Math/Array/ArrayRunTimeProperties.hxx +include/TFEL/Math/Array/ArrayRunTimeProperties.ixx +include/TFEL/Math/Array/ArrayStorage.hxx +include/TFEL/Math/Array/ArrayStorage.ixx +include/TFEL/Math/Array/Internals/ArraySerialize.hxx +include/TFEL/Math/Array/array.ixx +include/TFEL/Math/Array/arrayResultType.hxx +include/TFEL/Math/Bindings/atlas.hxx +include/TFEL/Math/Broyden.hxx +include/TFEL/Math/Broyden2.hxx +include/TFEL/Math/Composite/CompositeCompositeExpr.hxx +include/TFEL/Math/Composite/CompositeConcept.hxx +include/TFEL/Math/Composite/CompositeConceptOperations.ixx +include/TFEL/Math/Composite/CompositeExpr.hxx +include/TFEL/Math/Composite/CompositeNegExpr.hxx +include/TFEL/Math/Composite/CompositeScalarExpr.hxx +include/TFEL/Math/Composite/FctCompositeExpr.hxx +include/TFEL/Math/Composite/ScalarCompositeExpr.hxx +include/TFEL/Math/Composite/composite.ixx +include/TFEL/Math/Composite/compositeResultType.ixx +include/TFEL/Math/CubicSpline.hxx +include/TFEL/Math/CubicSpline.ixx +include/TFEL/Math/Discretization1D.hxx +include/TFEL/Math/Discretization1D.ixx +include/TFEL/Math/Evaluator.hxx +include/TFEL/Math/Evaluator.ixx +include/TFEL/Math/ExpressionTemplates/FctMathObjectExpr.hxx +include/TFEL/Math/ExpressionTemplates/FctMathObjectExprWithoutConstIterator.hxx +include/TFEL/Math/ExpressionTemplates/MathObjectMathObjectDiadicProductExpr.hxx +include/TFEL/Math/ExpressionTemplates/MathObjectMathObjectExpr.hxx +include/TFEL/Math/ExpressionTemplates/MathObjectMathObjectExprSpecialisation.ixx +include/TFEL/Math/ExpressionTemplates/MathObjectMathObjectExprWithoutConstIterator.hxx +include/TFEL/Math/ExpressionTemplates/MathObjectMathObjectExprWithoutConstIteratorSpecialisation.ixx +include/TFEL/Math/ExpressionTemplates/MathObjectNegExpr.hxx +include/TFEL/Math/ExpressionTemplates/MathObjectNegExprWithoutConstIterator.hxx +include/TFEL/Math/ExpressionTemplates/ScalarMathObjectExpr.hxx +include/TFEL/Math/ExpressionTemplates/ScalarMathObjectExprSpecialisation.ixx +include/TFEL/Math/ExpressionTemplates/ScalarMathObjectExprWithoutConstIterator.hxx +include/TFEL/Math/ExpressionTemplates/ScalarMathObjectExprWithoutConstIteratorSpecialisation.ixx +include/TFEL/Math/FSLevenbergMarquardt.hxx +include/TFEL/Math/FactorizedKriging.hxx +include/TFEL/Math/FactorizedKriging1D1D.hxx +include/TFEL/Math/FactorizedKriging1D2D.hxx +include/TFEL/Math/FactorizedKriging1D3D.hxx +include/TFEL/Math/Forward/ArrayConcept.hxx +include/TFEL/Math/Forward/Complex.hxx +include/TFEL/Math/Forward/CompositeConcept.hxx +include/TFEL/Math/Forward/ExpressionTemplates.hxx +include/TFEL/Math/Forward/Function.hxx +include/TFEL/Math/Forward/FunctionConcept.hxx +include/TFEL/Math/Forward/LambdaConcept.hxx +include/TFEL/Math/Forward/MatrixConcept.hxx +include/TFEL/Math/Forward/ST2toST2Concept.hxx +include/TFEL/Math/Forward/ST2toT2Concept.hxx +include/TFEL/Math/Forward/StensorConcept.hxx +include/TFEL/Math/Forward/T2toST2Concept.hxx +include/TFEL/Math/Forward/T2toT2Concept.hxx +include/TFEL/Math/Forward/TensorConcept.hxx +include/TFEL/Math/Forward/TinyNewtonRaphson.hxx +include/TFEL/Math/Forward/VectorConcept.hxx +include/TFEL/Math/Forward/array.hxx +include/TFEL/Math/Forward/lambda.hxx +include/TFEL/Math/Forward/matrix.hxx +include/TFEL/Math/Forward/qt.hxx +include/TFEL/Math/Forward/st2tost2.hxx +include/TFEL/Math/Forward/st2tot2.hxx +include/TFEL/Math/Forward/stensor.hxx +include/TFEL/Math/Forward/t2tost2.hxx +include/TFEL/Math/Forward/t2tot2.hxx +include/TFEL/Math/Forward/tensor.hxx +include/TFEL/Math/Forward/tmatrix.hxx +include/TFEL/Math/Forward/tvector.hxx +include/TFEL/Math/Forward/vector.hxx +include/TFEL/Math/Function/Cst.hxx +include/TFEL/Math/Function/Cst.ixx +include/TFEL/Math/Function/FunctionConcept.hxx +include/TFEL/Math/Function/FunctionConcept.ixx +include/TFEL/Math/Function/FunctionConceptOperations.hxx +include/TFEL/Math/Function/FunctionExpr.hxx +include/TFEL/Math/Function/FunctionFunctionExpr.hxx +include/TFEL/Math/Function/FunctionFunctionExpr.ixx +include/TFEL/Math/Function/FunctionNegExpr.hxx +include/TFEL/Math/Function/FunctionNegExpr.ixx +include/TFEL/Math/Function/FunctionScalarExpr.hxx +include/TFEL/Math/Function/FunctionScalarExpr.ixx +include/TFEL/Math/Function/FunctionsCompositionExpr.hxx +include/TFEL/Math/Function/FunctionsCompositionExpr.ixx +include/TFEL/Math/Function/Id.hxx +include/TFEL/Math/Function/Power.hxx +include/TFEL/Math/Function/Power.ixx +include/TFEL/Math/Function/ScalarFunctionExpr.hxx +include/TFEL/Math/Function/ScalarFunctionExpr.ixx +include/TFEL/Math/Function/StandardFunctions.hxx +include/TFEL/Math/General/Abs.hxx +include/TFEL/Math/General/Abs.ixx +include/TFEL/Math/General/AbsCompare.hxx +include/TFEL/Math/General/BaseCast.hxx +include/TFEL/Math/General/BasicOperations.hxx +include/TFEL/Math/General/Complex.hxx +include/TFEL/Math/General/Complex.ixx +include/TFEL/Math/General/ComputeBinaryResult.hxx +include/TFEL/Math/General/ComputeObjectTag.hxx +include/TFEL/Math/General/ComputeObjectTag.ixx +include/TFEL/Math/General/ComputeUnaryResult.hxx +include/TFEL/Math/General/CubicRoots.hxx +include/TFEL/Math/General/DotProduct.hxx +include/TFEL/Math/General/EmptyRunTimeProperties.hxx +include/TFEL/Math/General/FctObjectRandomAccessConstIterator.hxx +include/TFEL/Math/General/Forward/General.hxx +include/TFEL/Math/General/FracSimplify.hxx +include/TFEL/Math/General/FracSimplify.ixx +include/TFEL/Math/General/LogicalOperations.hxx +include/TFEL/Math/General/NegObjectRandomAccessConstIterator.hxx +include/TFEL/Math/General/ObjectObjectRandomAccessConstIterator.hxx +include/TFEL/Math/General/ObjectObjectRandomAccessConstIteratorSpecialisation.hxx +include/TFEL/Math/General/RandomRotationMatrix.hxx +include/TFEL/Math/General/ResultType.hxx +include/TFEL/Math/General/RunTimeCheck.hxx +include/TFEL/Math/General/ScalarObjectRandomAccessConstIterator.hxx +include/TFEL/Math/General/ScalarObjectRandomAccessConstIteratorSpecialisation.hxx +include/TFEL/Math/General/StorageTraits.hxx +include/TFEL/Math/General/UnaryResultType.hxx +include/TFEL/Math/General/floating_point_exceptions.hxx +include/TFEL/Math/General/fsarray.ixx +include/TFEL/Math/IntegerEvaluator.hxx +include/TFEL/Math/Kriging.hxx +include/TFEL/Math/Kriging/FactorizedKriging.ixx +include/TFEL/Math/Kriging/Kriging.ixx +include/TFEL/Math/Kriging/KrigingDefaultModel1D.hxx +include/TFEL/Math/Kriging/KrigingDefaultModel2D.hxx +include/TFEL/Math/Kriging/KrigingDefaultModel3D.hxx +include/TFEL/Math/Kriging/KrigingDefaultModels.hxx +include/TFEL/Math/Kriging/KrigingDefaultNuggetModel.hxx +include/TFEL/Math/Kriging/KrigingErrors.hxx +include/TFEL/Math/Kriging/KrigingPieceWiseLinearModel1D.hxx +include/TFEL/Math/Kriging/KrigingUtilities.hxx +include/TFEL/Math/Kriging/KrigingVariable.hxx +include/TFEL/Math/Kriging1D.hxx +include/TFEL/Math/Kriging2D.hxx +include/TFEL/Math/Kriging3D.hxx +include/TFEL/Math/LU/LUDecomp.hxx +include/TFEL/Math/LU/LUException.hxx +include/TFEL/Math/LU/Permutation.hxx +include/TFEL/Math/LU/Permutation.ixx +include/TFEL/Math/LU/TinyMatrixSolve.ixx +include/TFEL/Math/LU/TinyPermutation.hxx +include/TFEL/Math/LU/TinyPermutation.ixx +include/TFEL/Math/LUSolve.hxx +include/TFEL/Math/LambdaExpression/FctLambdaExpr.hxx +include/TFEL/Math/LambdaExpression/FctLambdaExpr.ixx +include/TFEL/Math/LambdaExpression/LambdaConcept.hxx +include/TFEL/Math/LambdaExpression/LambdaConcept.ixx +include/TFEL/Math/LambdaExpression/LambdaConceptOperations.hxx +include/TFEL/Math/LambdaExpression/LambdaConceptOperations.ixx +include/TFEL/Math/LambdaExpression/LambdaLambdaExpr.hxx +include/TFEL/Math/LambdaExpression/LambdaLambdaExpr.ixx +include/TFEL/Math/LambdaExpression/LambdaScalarExpr.hxx +include/TFEL/Math/LambdaExpression/LambdaScalarExpr.ixx +include/TFEL/Math/LambdaExpression/ScalarLambdaExpr.hxx +include/TFEL/Math/LambdaExpression/ScalarLambdaExpr.ixx +include/TFEL/Math/LambdaExpression/lambda.ixx +include/TFEL/Math/LevenbergMarquardt.hxx +include/TFEL/Math/LevenbergMarquardt/FSLevenbergMarquardt.ixx +include/TFEL/Math/LevenbergMarquardt/LevenbergMarquardt.ixx +include/TFEL/Math/LevenbergMarquardt/LevenbergMarquardtEvaluatorWrapper.hxx +include/TFEL/Math/LevenbergMarquardt/LevenbergMarquardtExternalFunctionWrapper.hxx +include/TFEL/Math/LevenbergMarquardt/LevenbergMarquardtFunctionWrapper.hxx +include/TFEL/Math/LevenbergMarquardt/LevenbergMarquardtFunctionWrapper.ixx +include/TFEL/Math/MathException.hxx +include/TFEL/Math/Matrix/MatrixConcept.hxx +include/TFEL/Math/Matrix/MatrixConcept.ixx +include/TFEL/Math/Matrix/MatrixConceptOperations.hxx +include/TFEL/Math/Matrix/MatrixConceptOperations.ixx +include/TFEL/Math/Matrix/MatrixExpr.hxx +include/TFEL/Math/Matrix/MatrixUtilities.hxx +include/TFEL/Math/Matrix/TMatrixTVectorExpr.hxx +include/TFEL/Math/Matrix/TVectorTMatrixExpr.hxx +include/TFEL/Math/Matrix/TinyMatrixInvert.ixx +include/TFEL/Math/Matrix/matrix.ixx +include/TFEL/Math/Matrix/tmatrix.ixx +include/TFEL/Math/Matrix/tmatrixResultType.hxx +include/TFEL/Math/Matrix/tmatrix_column_view.hxx +include/TFEL/Math/Matrix/tmatrix_column_view.ixx +include/TFEL/Math/Matrix/tmatrix_const_column_view.hxx +include/TFEL/Math/Matrix/tmatrix_const_column_view.ixx +include/TFEL/Math/Matrix/tmatrix_const_row_view.hxx +include/TFEL/Math/Matrix/tmatrix_const_row_view.ixx +include/TFEL/Math/Matrix/tmatrix_const_submatrix_view.hxx +include/TFEL/Math/Matrix/tmatrix_const_submatrix_view.ixx +include/TFEL/Math/Matrix/tmatrix_row_view.hxx +include/TFEL/Math/Matrix/tmatrix_row_view.ixx +include/TFEL/Math/Matrix/tmatrix_submatrix_view.hxx +include/TFEL/Math/Matrix/tmatrix_submatrix_view.ixx +include/TFEL/Math/Newton-Raphson/TinyNewtonRaphson.ixx +include/TFEL/Math/Parser/BinaryFunction.hxx +include/TFEL/Math/Parser/BinaryFunction.ixx +include/TFEL/Math/Parser/BinaryOperator.hxx +include/TFEL/Math/Parser/BinaryOperator.ixx +include/TFEL/Math/Parser/ConditionalExpr.hxx +include/TFEL/Math/Parser/ConstantExternalFunction.hxx +include/TFEL/Math/Parser/DifferentiatedFunctionExpr.hxx +include/TFEL/Math/Parser/EvaluatorBase.hxx +include/TFEL/Math/Parser/EvaluatorFunction.hxx +include/TFEL/Math/Parser/EvaluatorFunction.ixx +include/TFEL/Math/Parser/EvaluatorProxy.hxx +include/TFEL/Math/Parser/EvaluatorProxy.ixx +include/TFEL/Math/Parser/EvaluatorTExpr.hxx +include/TFEL/Math/Parser/EvaluatorTExpr.ixx +include/TFEL/Math/Parser/Expr.hxx +include/TFEL/Math/Parser/ExternalCFunction.hxx +include/TFEL/Math/Parser/ExternalCastemFunction.hxx +include/TFEL/Math/Parser/ExternalFunction.hxx +include/TFEL/Math/Parser/ExternalFunctionExpr.hxx +include/TFEL/Math/Parser/ExternalFunctionExpr2.hxx +include/TFEL/Math/Parser/ExternalFunctionManager.hxx +include/TFEL/Math/Parser/Function.hxx +include/TFEL/Math/Parser/Function.ixx +include/TFEL/Math/Parser/IntegerEvaluatorTExpr.hxx +include/TFEL/Math/Parser/KrigedFunction.hxx +include/TFEL/Math/Parser/KrigedFunction.ixx +include/TFEL/Math/Parser/LogicalExpr.hxx +include/TFEL/Math/Parser/LogicalExpr.ixx +include/TFEL/Math/Parser/Negation.hxx +include/TFEL/Math/Parser/Number.hxx +include/TFEL/Math/Parser/Variable.hxx +include/TFEL/Math/QR/QRDecomp.hxx +include/TFEL/Math/QR/QRDecomp.ixx +include/TFEL/Math/QR/QRException.hxx +include/TFEL/Math/Quantity/Unit.hxx +include/TFEL/Math/Quantity/Unit.ixx +include/TFEL/Math/Quantity/qt.ixx +include/TFEL/Math/Quantity/qtLimits.hxx +include/TFEL/Math/Quantity/qtOperations.hxx +include/TFEL/Math/Quantity/qtOperations.ixx +include/TFEL/Math/Quantity/qtSamples.hxx +include/TFEL/Math/Quantity/qtSpecific.hxx +include/TFEL/Math/RootFinding/Broyden.ixx +include/TFEL/Math/RootFinding/Broyden2.ixx +include/TFEL/Math/RungeKutta/RungeKutta2.ixx +include/TFEL/Math/RungeKutta/RungeKutta4.ixx +include/TFEL/Math/RungeKutta/RungeKutta42.ixx +include/TFEL/Math/RungeKutta/RungeKutta54.ixx +include/TFEL/Math/RungeKutta2.hxx +include/TFEL/Math/RungeKutta4.hxx +include/TFEL/Math/RungeKutta42.hxx +include/TFEL/Math/RungeKutta54.hxx +include/TFEL/Math/ST2toST2/ConvertT2toST2ToST2toST2Expr.hxx +include/TFEL/Math/ST2toST2/ST2toST2Concept.hxx +include/TFEL/Math/ST2toST2/ST2toST2Concept.ixx +include/TFEL/Math/ST2toST2/ST2toST2ConceptOperations.hxx +include/TFEL/Math/ST2toST2/ST2toST2Expr.hxx +include/TFEL/Math/ST2toST2/ST2toST2FromTinyMatrixView.hxx +include/TFEL/Math/ST2toST2/ST2toST2FromTinyMatrixView2.hxx +include/TFEL/Math/ST2toST2/ST2toST2ST2toST2ProductExpr.hxx +include/TFEL/Math/ST2toST2/ST2toST2StensorProductExpr.hxx +include/TFEL/Math/ST2toST2/StensorST2toST2ProductExpr.hxx +include/TFEL/Math/ST2toST2/StensorSquareDerivative.hxx +include/TFEL/Math/ST2toST2/st2tost2.ixx +include/TFEL/Math/ST2toST2/st2tost2ResultType.hxx +include/TFEL/Math/ST2toT2/ST2toT2Concept.hxx +include/TFEL/Math/ST2toT2/ST2toT2Concept.ixx +include/TFEL/Math/ST2toT2/ST2toT2ConceptOperations.hxx +include/TFEL/Math/ST2toT2/ST2toT2Expr.hxx +include/TFEL/Math/ST2toT2/ST2toT2FromTinyMatrixView.hxx +include/TFEL/Math/ST2toT2/ST2toT2FromTinyMatrixView2.hxx +include/TFEL/Math/ST2toT2/ST2toT2ST2toST2ProductExpr.hxx +include/TFEL/Math/ST2toT2/ST2toT2StensorProductExpr.hxx +include/TFEL/Math/ST2toT2/ST2toT2T2toST2ProductExpr.hxx +include/TFEL/Math/ST2toT2/StensorProductLeftDerivativeExpr.hxx +include/TFEL/Math/ST2toT2/StensorProductRightDerivativeExpr.hxx +include/TFEL/Math/ST2toT2/T2toST2ST2toT2ProductExpr.hxx +include/TFEL/Math/ST2toT2/T2toT2ST2toT2ProductExpr.hxx +include/TFEL/Math/ST2toT2/TensorST2toT2ProductExpr.hxx +include/TFEL/Math/ST2toT2/TensorStensorDiadicProductExpr.hxx +include/TFEL/Math/ST2toT2/st2tot2.ixx +include/TFEL/Math/ST2toT2/st2tot2ResultType.hxx +include/TFEL/Math/Stensor/DecompositionInPositiveAndNegativeParts.hxx +include/TFEL/Math/Stensor/DecompositionInPositiveAndNegativeParts.ixx +include/TFEL/Math/Stensor/Internals/StensorChangeBasis.hxx +include/TFEL/Math/Stensor/Internals/StensorComputeEigenValues.hxx +include/TFEL/Math/Stensor/Internals/StensorComputeEigenVectors.hxx +include/TFEL/Math/Stensor/Internals/StensorExport.hxx +include/TFEL/Math/Stensor/Internals/StensorExport.ixx +include/TFEL/Math/Stensor/Internals/StensorImport.hxx +include/TFEL/Math/Stensor/StensorConcept.hxx +include/TFEL/Math/Stensor/StensorConcept.ixx +include/TFEL/Math/Stensor/StensorConceptOperations.hxx +include/TFEL/Math/Stensor/StensorConceptOperations.ixx +include/TFEL/Math/Stensor/StensorExpr.hxx +include/TFEL/Math/Stensor/StensorExternalTabStorage.hxx +include/TFEL/Math/Stensor/StensorExternalVoigtStorage.hxx +include/TFEL/Math/Stensor/StensorFromTinyMatrixColumnView.hxx +include/TFEL/Math/Stensor/StensorFromTinyMatrixColumnView2.hxx +include/TFEL/Math/Stensor/StensorFromTinyMatrixRowView.hxx +include/TFEL/Math/Stensor/StensorFromTinyMatrixRowView2.hxx +include/TFEL/Math/Stensor/StensorFromTinyVectorView.hxx +include/TFEL/Math/Stensor/StensorNullStorage.hxx +include/TFEL/Math/Stensor/StensorProduct.hxx +include/TFEL/Math/Stensor/StensorSizeToDime.hxx +include/TFEL/Math/Stensor/StensorSquare.hxx +include/TFEL/Math/Stensor/StensorStaticStorage.hxx +include/TFEL/Math/Stensor/stensor.ixx +include/TFEL/Math/Stensor/stensorResultType.hxx +include/TFEL/Math/T2toST2/LeftCauchyGreenTensorDerivativeExpr.hxx +include/TFEL/Math/T2toST2/RightCauchyGreenTensorDerivativeExpr.hxx +include/TFEL/Math/T2toST2/ST2toST2T2toST2ProductExpr.hxx +include/TFEL/Math/T2toST2/StensorT2toST2ProductExpr.hxx +include/TFEL/Math/T2toST2/StensorTensorDiadicProductExpr.hxx +include/TFEL/Math/T2toST2/T2toST2Concept.hxx +include/TFEL/Math/T2toST2/T2toST2Concept.ixx +include/TFEL/Math/T2toST2/T2toST2ConceptOperations.hxx +include/TFEL/Math/T2toST2/T2toST2Expr.hxx +include/TFEL/Math/T2toST2/T2toST2FromTinyMatrixView.hxx +include/TFEL/Math/T2toST2/T2toST2FromTinyMatrixView2.hxx +include/TFEL/Math/T2toST2/T2toST2T2toT2ProductExpr.hxx +include/TFEL/Math/T2toST2/T2toST2TensorProductExpr.hxx +include/TFEL/Math/T2toST2/t2tost2.ixx +include/TFEL/Math/T2toST2/t2tost2ResultType.hxx +include/TFEL/Math/T2toT2/T2toT2Concept.hxx +include/TFEL/Math/T2toT2/T2toT2Concept.ixx +include/TFEL/Math/T2toT2/T2toT2ConceptOperations.hxx +include/TFEL/Math/T2toT2/T2toT2Expr.hxx +include/TFEL/Math/T2toT2/T2toT2FromTinyMatrixView.hxx +include/TFEL/Math/T2toT2/T2toT2FromTinyMatrixView2.hxx +include/TFEL/Math/T2toT2/T2toT2T2toT2ProductExpr.hxx +include/TFEL/Math/T2toT2/T2toT2TensorProductExpr.hxx +include/TFEL/Math/T2toT2/TensorProductLeftDerivativeExpr.hxx +include/TFEL/Math/T2toT2/TensorProductRightDerivativeExpr.hxx +include/TFEL/Math/T2toT2/TensorT2toT2ProductExpr.hxx +include/TFEL/Math/T2toT2/t2tot2.ixx +include/TFEL/Math/T2toT2/t2tot2ResultType.hxx +include/TFEL/Math/Tensor/MatrixViewFromTensor.hxx +include/TFEL/Math/Tensor/TensorChangeBasis.hxx +include/TFEL/Math/Tensor/TensorConcept.hxx +include/TFEL/Math/Tensor/TensorConcept.ixx +include/TFEL/Math/Tensor/TensorConceptOperations.hxx +include/TFEL/Math/Tensor/TensorConceptOperations.ixx +include/TFEL/Math/Tensor/TensorExpr.hxx +include/TFEL/Math/Tensor/TensorFromTinyMatrixColumnView.hxx +include/TFEL/Math/Tensor/TensorFromTinyMatrixColumnView2.hxx +include/TFEL/Math/Tensor/TensorFromTinyMatrixRowView.hxx +include/TFEL/Math/Tensor/TensorFromTinyMatrixRowView2.hxx +include/TFEL/Math/Tensor/TensorFromTinyVectorView.hxx +include/TFEL/Math/Tensor/TensorProduct.hxx +include/TFEL/Math/Tensor/TensorSizeToDime.hxx +include/TFEL/Math/Tensor/TensorTransposeExpr.hxx +include/TFEL/Math/Tensor/TensorViewFromStensor.hxx +include/TFEL/Math/Tensor/tensor.ixx +include/TFEL/Math/Tensor/tensorResultType.hxx +include/TFEL/Math/TinyMatrixInvert.hxx +include/TFEL/Math/TinyMatrixSolve.hxx +include/TFEL/Math/TinyNewtonRaphson.hxx +include/TFEL/Math/Vector/Range.hxx +include/TFEL/Math/Vector/TVectorFromTinyMatrixColumnView.hxx +include/TFEL/Math/Vector/TVectorFromTinyMatrixColumnView2.hxx +include/TFEL/Math/Vector/TVectorFromTinyMatrixRowView.hxx +include/TFEL/Math/Vector/TVectorFromTinyMatrixRowView2.hxx +include/TFEL/Math/Vector/TVectorFromTinyVectorView.hxx +include/TFEL/Math/Vector/TinyVectorFromTinyVectorView.hxx +include/TFEL/Math/Vector/TinyVectorOfStensorFromTinyVectorView.hxx +include/TFEL/Math/Vector/TinyVectorOfTinyVectorFromTinyVectorView.hxx +include/TFEL/Math/Vector/VectorConcept.hxx +include/TFEL/Math/Vector/VectorConcept.ixx +include/TFEL/Math/Vector/VectorConceptOperations.hxx +include/TFEL/Math/Vector/VectorConceptOperations.ixx +include/TFEL/Math/Vector/VectorExpr.hxx +include/TFEL/Math/Vector/VectorUtilities.hxx +include/TFEL/Math/Vector/VectorVectorDotProduct.hxx +include/TFEL/Math/Vector/tvector.ixx +include/TFEL/Math/Vector/tvectorResultType.hxx +include/TFEL/Math/Vector/vector.ixx +include/TFEL/Math/Vector/vectorResultType.hxx +include/TFEL/Math/array.hxx +include/TFEL/Math/composite.hxx +include/TFEL/Math/fsarray.hxx +include/TFEL/Math/functions.hxx +include/TFEL/Math/lambda.hxx +include/TFEL/Math/matrix.hxx +include/TFEL/Math/power.hxx +include/TFEL/Math/power.ixx +include/TFEL/Math/qt.hxx +include/TFEL/Math/st2tost2.hxx +include/TFEL/Math/st2tot2.hxx +include/TFEL/Math/stensor.hxx +include/TFEL/Math/t2tost2.hxx +include/TFEL/Math/t2tot2.hxx +include/TFEL/Math/tensor.hxx +include/TFEL/Math/tmatrix.hxx +include/TFEL/Math/tvector.hxx +include/TFEL/Math/vector.hxx +include/TFEL/Metaprogramming/EmptyClass.hxx +include/TFEL/Metaprogramming/EnableIf.hxx +include/TFEL/Metaprogramming/Forward/TypeList.hxx +include/TFEL/Metaprogramming/GenerateTypeList.hxx +include/TFEL/Metaprogramming/GenerateTypeList.ixx +include/TFEL/Metaprogramming/HasConstIterator.hxx +include/TFEL/Metaprogramming/HasIterator.hxx +include/TFEL/Metaprogramming/HasRandomAccessConstIterator.hxx +include/TFEL/Metaprogramming/HasRandomAccessIterator.hxx +include/TFEL/Metaprogramming/IF.hxx +include/TFEL/Metaprogramming/Implements.hxx +include/TFEL/Metaprogramming/IntToType.hxx +include/TFEL/Metaprogramming/InvalidType.hxx +include/TFEL/Metaprogramming/IsConvertibleTo.hxx +include/TFEL/Metaprogramming/IsPointer.hxx +include/TFEL/Metaprogramming/IsReference.hxx +include/TFEL/Metaprogramming/IsSameType.hxx +include/TFEL/Metaprogramming/IsSubClassOf.hxx +include/TFEL/Metaprogramming/IsSuperClassOf.hxx +include/TFEL/Metaprogramming/RemoveConstness.hxx +include/TFEL/Metaprogramming/RemoveReference.hxx +include/TFEL/Metaprogramming/StaticAssert.hxx +include/TFEL/Metaprogramming/TypeList.hxx +include/TFEL/Metaprogramming/TypeList.ixx +include/TFEL/System/BinaryRead.hxx +include/TFEL/System/BinaryWrite.hxx +include/TFEL/System/ChildProcess.hxx +include/TFEL/System/ExternalBehaviourDescription.hxx +include/TFEL/System/ExternalFunctionsPrototypes.hxx +include/TFEL/System/ExternalLibraryManager.hxx +include/TFEL/System/ProcessManager.h +include/TFEL/System/ProcessManager.hxx +include/TFEL/System/RecursiveFind.hxx +include/TFEL/System/STLContainerBinaryRead.hxx +include/TFEL/System/STLContainerBinaryWrite.hxx +include/TFEL/System/SignalHandler.hxx +include/TFEL/System/SignalHandler.ixx +include/TFEL/System/SignalManager.hxx +include/TFEL/System/System.hxx +include/TFEL/System/SystemError.hxx +include/TFEL/System/SystemError.ixx +include/TFEL/System/basic_rstream.hxx +include/TFEL/System/basic_rstream.ixx +include/TFEL/System/basic_wstream.hxx +include/TFEL/System/basic_wstream.ixx +include/TFEL/System/getFunction.h +include/TFEL/System/rfstream.hxx +include/TFEL/System/rstreamView.hxx +include/TFEL/System/rstreamView.ixx +include/TFEL/System/stream_traits.hxx +include/TFEL/System/wfstream.hxx +include/TFEL/System/wstreamView.hxx +include/TFEL/System/wstreamView.ixx +include/TFEL/Tests/MultipleTestOutputs.hxx +include/TFEL/Tests/StdStreamTestOutput.hxx +include/TFEL/Tests/Test.hxx +include/TFEL/Tests/TestCase.hxx +include/TFEL/Tests/TestFunctionWrapper.hxx +include/TFEL/Tests/TestFunctionWrapper.ixx +include/TFEL/Tests/TestManager.hxx +include/TFEL/Tests/TestOutput.hxx +include/TFEL/Tests/TestProxy.hxx +include/TFEL/Tests/TestProxy.ixx +include/TFEL/Tests/TestResult.hxx +include/TFEL/Tests/TestSuite.hxx +include/TFEL/Tests/XMLTestOutput.hxx +include/TFEL/TypeTraits/AbsType.hxx +include/TFEL/TypeTraits/BaseType.hxx +include/TFEL/TypeTraits/IsAssignableTo.hxx +include/TFEL/TypeTraits/IsComplex.hxx +include/TFEL/TypeTraits/IsFundamentalNumericType.hxx +include/TFEL/TypeTraits/IsInvalid.hxx +include/TFEL/TypeTraits/IsRandomAccessIterator.hxx +include/TFEL/TypeTraits/IsReal.hxx +include/TFEL/TypeTraits/IsSafelyReinterpretCastableTo.hxx +include/TFEL/TypeTraits/IsScalar.hxx +include/TFEL/TypeTraits/IsTemporary.hxx +include/TFEL/TypeTraits/IsUnaryOperator.hxx +include/TFEL/TypeTraits/Promote.hxx +include/TFEL/TypeTraits/Promote/Promote.ixx +include/TFEL/TypeTraits/RealPartType.hxx +include/TFEL/Utilities/ArgumentParserBase.hxx +include/TFEL/Utilities/ArgumentParserBase.ixx +include/TFEL/Utilities/Config.hxx +include/TFEL/Utilities/ConfigParser.hxx +include/TFEL/Utilities/ContainerRebind.hxx +include/TFEL/Utilities/CxxKeywords.hxx +include/TFEL/Utilities/CxxTokenizer.hxx +include/TFEL/Utilities/CxxTokenizer.ixx +include/TFEL/Utilities/GenTypeBase.hxx +include/TFEL/Utilities/GenTypeBase.ixx +include/TFEL/Utilities/GenTypeCastError.hxx +include/TFEL/Utilities/GenTypeSpecialisation.ixx +include/TFEL/Utilities/Global.hxx +include/TFEL/Utilities/Info.hxx +include/TFEL/Utilities/IntegersSet.hxx +include/TFEL/Utilities/LaTeXConvertion.hxx +include/TFEL/Utilities/MTestDocParser.hxx +include/TFEL/Utilities/MallocAllocator.hxx +include/TFEL/Utilities/MultipleDeque.hxx +include/TFEL/Utilities/MultipleDequeVector/MultipleDequeVector.hxx +include/TFEL/Utilities/MultipleDequeVector/MultipleDequeVector.ixx +include/TFEL/Utilities/MultipleDequeVector/MultipleDequeVectorIterators.ixx +include/TFEL/Utilities/MultipleDequeVector/TypeTransform.hxx +include/TFEL/Utilities/MultipleDequeVector/TypeTransform.ixx +include/TFEL/Utilities/MultipleVector.hxx +include/TFEL/Utilities/Name.hxx +include/TFEL/Utilities/Name.ixx +include/TFEL/Utilities/NewAllocator.hxx +include/TFEL/Utilities/ParserBase.hxx +include/TFEL/Utilities/RecursiveUnion.hxx +include/TFEL/Utilities/SmartPtr.hxx +include/TFEL/Utilities/StringAlgorithms.hxx +include/TFEL/Utilities/TerminalColors.hxx +include/TFEL/Utilities/TestDocMain.hxx +include/TFEL/Utilities/TestDocParser.hxx +include/TFEL/Utilities/TestDocumentation.hxx +include/TFEL/Utilities/TextData.hxx +include/TFEL/Utilities/ToString.hxx +include/TFEL/Utilities/ToString.ixx +include/TFEL/Utilities/Token.hxx +include/TFEL/Utilities/Tuple.hxx +include/TFEL/Utilities/Tuple.ixx +lib/libAsterInterface.so +lib/libAsterInterface.so.0 +lib/libAsterInterface.so.0.0.0 +lib/libMFrontLogStream.so +lib/libMFrontLogStream.so.0 +lib/libMFrontLogStream.so.0.0.0 +lib/libMTestFileGenerator.so +lib/libMTestFileGenerator.so.0 +lib/libMTestFileGenerator.so.0.0.0 +lib/libTFELException.so +lib/libTFELException.so.0 +lib/libTFELException.so.0.0.0 +lib/libTFELGlossary.so +lib/libTFELGlossary.so.0 +lib/libTFELGlossary.so.0.0.0 +lib/libTFELMTest.so +lib/libTFELMTest.so.0 +lib/libTFELMTest.so.0.0.0 +lib/libTFELMaterial.so +lib/libTFELMaterial.so.0 +lib/libTFELMaterial.so.0.0.0 +lib/libTFELMath.so +lib/libTFELMath.so.0 +lib/libTFELMath.so.0.0.0 +lib/libTFELMathCubicSpline.so +lib/libTFELMathCubicSpline.so.0 +lib/libTFELMathCubicSpline.so.0.0.0 +lib/libTFELMathKriging.so +lib/libTFELMathKriging.so.0 +lib/libTFELMathKriging.so.0.0.0 +lib/libTFELMathParser.so +lib/libTFELMathParser.so.0 +lib/libTFELMathParser.so.0.0.0 +lib/libTFELSystem.so +lib/libTFELSystem.so.0 +lib/libTFELSystem.so.0.0.0 +lib/libTFELTests.so +lib/libTFELTests.so.0 +lib/libTFELTests.so.0.0.0 +lib/libTFELUtilities.so +lib/libTFELUtilities.so.0 +lib/libTFELUtilities.so.0.0.0 +%%PORTDOCS%%%%DOCSDIR%%/AccelerationAlgorithm.md +%%PORTDOCS%%%%DOCSDIR%%/AccelerationAlgorithmParameter.md +%%PORTDOCS%%%%DOCSDIR%%/Author.md +%%PORTDOCS%%%%DOCSDIR%%/Behaviour.md +%%PORTDOCS%%%%DOCSDIR%%/CastemAccelerationPeriod.md +%%PORTDOCS%%%%DOCSDIR%%/CastemAccelerationTrigger.md +%%PORTDOCS%%%%DOCSDIR%%/CohesiveForce.md +%%PORTDOCS%%%%DOCSDIR%%/CohesiveForceEpsilon.md +%%PORTDOCS%%%%DOCSDIR%%/CompareToNumericalTangentOperator.md +%%PORTDOCS%%%%DOCSDIR%%/Date.md +%%PORTDOCS%%%%DOCSDIR%%/DeformationGradient.md +%%PORTDOCS%%%%DOCSDIR%%/DeformationGradientEpsilon.md +%%PORTDOCS%%%%DOCSDIR%%/Description.md +%%PORTDOCS%%%%DOCSDIR%%/Evolution.md +%%PORTDOCS%%%%DOCSDIR%%/ExternalStateVariable.md +%%PORTDOCS%%%%DOCSDIR%%/ImposedStrain.md +%%PORTDOCS%%%%DOCSDIR%%/ImposedStress.md +%%PORTDOCS%%%%DOCSDIR%%/IntegerParameter.md +%%PORTDOCS%%%%DOCSDIR%%/InternalStateVariable.md +%%PORTDOCS%%%%DOCSDIR%%/MaterialProperty.md +%%PORTDOCS%%%%DOCSDIR%%/MaximumNumberOfIterations.md +%%PORTDOCS%%%%DOCSDIR%%/MaximumNumberOfSubSteps.md +%%PORTDOCS%%%%DOCSDIR%%/ModellingHypothesis.md +%%PORTDOCS%%%%DOCSDIR%%/NumericalTangentOperatorPerturbationValue.md +%%PORTDOCS%%%%DOCSDIR%%/OutOfBoundsPolicy.md +%%PORTDOCS%%%%DOCSDIR%%/OutputFile.md +%%PORTDOCS%%%%DOCSDIR%%/OutputFilePrecision.md +%%PORTDOCS%%%%DOCSDIR%%/Parameter.md +%%PORTDOCS%%%%DOCSDIR%%/PredictionPolicy.md +%%PORTDOCS%%%%DOCSDIR%%/Real.md +%%PORTDOCS%%%%DOCSDIR%%/RotationMatrix.md +%%PORTDOCS%%%%DOCSDIR%%/StiffnessMatrixType.md +%%PORTDOCS%%%%DOCSDIR%%/StiffnessUpdatePolicy.md +%%PORTDOCS%%%%DOCSDIR%%/Strain.md +%%PORTDOCS%%%%DOCSDIR%%/StrainEpsilon.md +%%PORTDOCS%%%%DOCSDIR%%/Stress.md +%%PORTDOCS%%%%DOCSDIR%%/StressEpsilon.md +%%PORTDOCS%%%%DOCSDIR%%/Test.md +%%PORTDOCS%%%%DOCSDIR%%/Times.md +%%PORTDOCS%%%%DOCSDIR%%/UnsignedIntegerParameter.md +%%PORTDOCS%%%%DOCSDIR%%/UseCastemAccelerationAlgorithm.md +%%DATADIR%%/Examples/elasticity.mfront +%%DATADIR%%/Examples/implicit.mfront +%%DATADIR%%/Examples/norton.mfront +%%DATADIR%%/Examples/plasticity.mfront +%%DATADIR%%/Examples/rungekutta54.mfront +%%DATADIR%%/Examples/win32.txt +%%DATADIR%%/LICENCE-CECILL-A-EN +%%DATADIR%%/LICENCE-CECILL-A-FR +%%DATADIR%%/LICENCE-GNU-GPL +%%DATADIR%%/mfront/tests/behaviours/AgeingBurger.mfront +%%DATADIR%%/mfront/tests/behaviours/AnistropicLemaitreViscoplasticBehaviour.mfront +%%DATADIR%%/mfront/tests/behaviours/Burger.mfront +%%DATADIR%%/mfront/tests/behaviours/Chaboche.mfront +%%DATADIR%%/mfront/tests/behaviours/Chaboche2.mfront +%%DATADIR%%/mfront/tests/behaviours/CompressibleNeoHookeanBehaviour.mfront +%%DATADIR%%/mfront/tests/behaviours/DDIF2.mfront +%%DATADIR%%/mfront/tests/behaviours/DruckerPrager.mfront +%%DATADIR%%/mfront/tests/behaviours/DruckerPragerEcroLin.mfront +%%DATADIR%%/mfront/tests/behaviours/DruckerPragerEcroLinDefault.mfront +%%DATADIR%%/mfront/tests/behaviours/Elasticity.mfront +%%DATADIR%%/mfront/tests/behaviours/Elasticity2.mfront +%%DATADIR%%/mfront/tests/behaviours/Elasticity3.mfront +%%DATADIR%%/mfront/tests/behaviours/EllipticCreep.mfront +%%DATADIR%%/mfront/tests/behaviours/ExternalStateVariablesBoundsCheck.mfront +%%DATADIR%%/mfront/tests/behaviours/FiniteRotationSmallStrainElasticity.mfront +%%DATADIR%%/mfront/tests/behaviours/FiniteRotationSmallStrainElasticity2.mfront +%%DATADIR%%/mfront/tests/behaviours/FiniteStrainSingleCrystal.mfront +%%DATADIR%%/mfront/tests/behaviours/FiniteStrainSingleCrystal2.mfront +%%DATADIR%%/mfront/tests/behaviours/FiniteStrainSingleCrystal_NumericalJacobian.mfront +%%DATADIR%%/mfront/tests/behaviours/GeneralizedMaxwell.mfront +%%DATADIR%%/mfront/tests/behaviours/GursonTvergaardNeedlemanPlasticFlow_NumericalJacobian.mfront +%%DATADIR%%/mfront/tests/behaviours/GursonTvergaardNeedlemanViscoPlasticFlow_NumericalJacobian.mfront +%%DATADIR%%/mfront/tests/behaviours/Hayhurst.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitFiniteStrainNorton.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitHayhurst.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitMonoCrystal.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitNorton.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitNorton2.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitNorton3.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitNorton_Broyden.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitNorton_Broyden2.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitNorton_LevenbergMarquardt.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitOrthotropicCreep.mfront +%%DATADIR%%/mfront/tests/behaviours/ImplicitSimoMieheElastoPlasticity.mfront +%%DATADIR%%/mfront/tests/behaviours/IncompressibleMooneyRivlinBehaviour.mfront +%%DATADIR%%/mfront/tests/behaviours/IncompressiblePlaneStressGornetDesmoratBehaviour.mfront +%%DATADIR%%/mfront/tests/behaviours/IncompressiblePlaneStressMooneyRivlinBehaviour.mfront +%%DATADIR%%/mfront/tests/behaviours/LogarithmicStrainElasticity.mfront +%%DATADIR%%/mfront/tests/behaviours/LogarithmicStrainElasticity2.mfront +%%DATADIR%%/mfront/tests/behaviours/LogarithmicStrainNortonCreep.mfront +%%DATADIR%%/mfront/tests/behaviours/LogarithmicStrainPlasticity.mfront +%%DATADIR%%/mfront/tests/behaviours/Lorentz.mfront +%%DATADIR%%/mfront/tests/behaviours/Lorentz2.mfront +%%DATADIR%%/mfront/tests/behaviours/MaterialPropertiesBoundsCheck.mfront +%%DATADIR%%/mfront/tests/behaviours/Mazars.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystalNewtonRaphson.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CC.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CC_InteractionMatrix.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CC_Irradiation.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CC_Irradiation_NumericalJacobian.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CC_LevenbergMarquardt.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CC_NumericalJacobian.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CC_SlidingSystems.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CFC.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CFC_InteractionMatrix.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CFC_Irradiation.mfront +%%DATADIR%%/mfront/tests/behaviours/MonoCrystal_DD_CFC_NumericalJacobian.mfront +%%DATADIR%%/mfront/tests/behaviours/Norton.mfront +%%DATADIR%%/mfront/tests/behaviours/NortonRK.mfront +%%DATADIR%%/mfront/tests/behaviours/NortonRK2.mfront +%%DATADIR%%/mfront/tests/behaviours/NortonRK3.mfront +%%DATADIR%%/mfront/tests/behaviours/NortonRK4.mfront +%%DATADIR%%/mfront/tests/behaviours/Norton_Euler.mfront +%%DATADIR%%/mfront/tests/behaviours/Norton_rk2.mfront +%%DATADIR%%/mfront/tests/behaviours/Norton_rk4.mfront +%%DATADIR%%/mfront/tests/behaviours/Norton_rk42.mfront +%%DATADIR%%/mfront/tests/behaviours/Norton_rkCastem.mfront +%%DATADIR%%/mfront/tests/behaviours/OrthotropicCreep.mfront +%%DATADIR%%/mfront/tests/behaviours/OrthotropicCreep_rk42.mfront +%%DATADIR%%/mfront/tests/behaviours/OrthotropicCreep_rkCastem.mfront +%%DATADIR%%/mfront/tests/behaviours/OrthotropicElastic.mfront +%%DATADIR%%/mfront/tests/behaviours/OrthotropicElastic2.mfront +%%DATADIR%%/mfront/tests/behaviours/PlasIsoCin.mfront +%%DATADIR%%/mfront/tests/behaviours/Plasticity.mfront +%%DATADIR%%/mfront/tests/behaviours/PolyCrystals.mfront +%%DATADIR%%/mfront/tests/behaviours/PolyCrystals_DD_CC.mfront +%%DATADIR%%/mfront/tests/behaviours/PolyCrystals_DD_CFC.mfront +%%DATADIR%%/mfront/tests/behaviours/SaintVenantKirchhoffElasticity.mfront +%%DATADIR%%/mfront/tests/behaviours/SaintVenantKirchhoffElasticity2.mfront +%%DATADIR%%/mfront/tests/behaviours/SaintVenantKirchhoffElasticity3.mfront +%%DATADIR%%/mfront/tests/behaviours/SlidingSystemsCC.mfront +%%DATADIR%%/mfront/tests/behaviours/StateVariablesBoundsCheck.mfront +%%DATADIR%%/mfront/tests/behaviours/StrainHardeningCreep.mfront +%%DATADIR%%/mfront/tests/behaviours/T91ViscoplasticBehaviour.mfront +%%DATADIR%%/mfront/tests/behaviours/Tvergaard.mfront +%%DATADIR%%/mfront/tests/behaviours/ViscoChaboche.mfront +%%DATADIR%%/mfront/tests/behaviours/ViscoMemoNrad.mfront +%%DATADIR%%/mfront/tests/behaviours/ViscoPlasIsoCin.mfront Property changes on: head/science/tfel/pkg-plist ___________________________________________________________________ Added: fbsd:nokeywords ## -0,0 +1 ## +on \ No newline at end of property Added: svn:eol-style ## -0,0 +1 ## +native \ No newline at end of property Added: svn:mime-type ## -0,0 +1 ## +text/plain \ No newline at end of property