From 3c2a5c0e94a4428d5600eea113784d39d2ee30ec Mon Sep 17 00:00:00 2001 From: Dmitri Naumov <github@naumov.de> Date: Fri, 2 Jul 2021 14:56:28 +0200 Subject: [PATCH] [PL] Use int type for GlobalDim template argument. --- NumLib/Fem/ShapeMatrixPolicy.h | 8 +-- ...DirichletBoundaryConditionLocalAssembler.h | 3 +- .../GenericNaturalBoundaryCondition-impl.h | 6 +-- .../GenericNaturalBoundaryCondition.h | 3 +- ...icNaturalBoundaryConditionLocalAssembler.h | 3 +- ...onentFlowBoundaryConditionLocalAssembler.h | 3 +- .../NeumannBoundaryConditionLocalAssembler.h | 3 +- .../NormalTractionBoundaryCondition-impl.h | 8 +-- .../NormalTractionBoundaryCondition.h | 4 +- ...lTractionBoundaryConditionLocalAssembler.h | 6 +-- .../PythonBoundaryConditionLocalAssembler.h | 3 +- .../RobinBoundaryConditionLocalAssembler.h | 3 +- ...ntNeumannBoundaryConditionLocalAssembler.h | 3 +- .../ComponentTransportFEM.h | 3 +- ProcessLib/Deformation/BMatrixPolicy.h | 2 +- ProcessLib/Deformation/GMatrixPolicy.h | 2 +- ProcessLib/HT/HTFEM.h | 3 +- ProcessLib/HT/MonolithicHTFEM.h | 3 +- ProcessLib/HT/StaggeredHTFEM-impl.h | 12 ++--- ProcessLib/HT/StaggeredHTFEM.h | 3 +- ProcessLib/HeatConduction/HeatConductionFEM.h | 5 +- ProcessLib/LIE/Common/HMatrixUtils.h | 4 +- .../CreateHydroMechanicsProcess.cpp | 2 +- .../CreateHydroMechanicsProcess.h | 2 +- .../HydroMechanicsProcessData.h | 2 +- .../IntegrationPointDataFracture.h | 2 +- .../IntegrationPointDataMatrix.h | 3 +- .../LiquidFlowLocalAssembler-impl.h | 27 ++++------ .../LiquidFlow/LiquidFlowLocalAssembler.h | 3 +- ProcessLib/LocalAssemblerTraits.h | 12 +++-- .../RichardsComponentTransportFEM-impl.h | 15 ++---- .../RichardsComponentTransportFEM.h | 3 +- ProcessLib/RichardsFlow/RichardsFlowFEM.h | 3 +- .../Python/PythonSourceTermLocalAssembler.h | 3 +- .../SourceTerms/VolumetricSourceTermFEM.h | 3 +- .../SteadyStateDiffusionFEM.h | 3 +- .../SurfaceFlux/SurfaceFluxLocalAssembler.h | 3 +- ProcessLib/TES/TESLocalAssembler-impl.h | 31 +++++------- ProcessLib/TES/TESLocalAssembler.h | 6 +-- ...malTwoPhaseFlowWithPPLocalAssembler-impl.h | 3 +- .../ThermalTwoPhaseFlowWithPPLocalAssembler.h | 3 +- .../ThermoRichardsFlowFEM-impl.h | 49 +++++++------------ .../ThermoRichardsFlowFEM.h | 3 +- .../TwoPhaseFlowWithPPLocalAssembler-impl.h | 3 +- .../TwoPhaseFlowWithPPLocalAssembler.h | 3 +- .../TwoPhaseFlowWithPrhoLocalAssembler-impl.h | 3 +- .../TwoPhaseFlowWithPrhoLocalAssembler.h | 3 +- ProcessLib/Utils/CreateLocalAssemblers.h | 8 ++- ProcessLib/Utils/LocalDataInitializer.h | 4 +- .../MathLib/TestGaussLegendreIntegration.cpp | 3 +- Tests/NumLib/TestExtrapolation.cpp | 3 +- Tests/NumLib/TestFe.cpp | 5 +- Tests/NumLib/TestGradShapeFunction.cpp | 9 ++-- 53 files changed, 121 insertions(+), 197 deletions(-) diff --git a/NumLib/Fem/ShapeMatrixPolicy.h b/NumLib/Fem/ShapeMatrixPolicy.h index e0a7e212ed6..749998befb9 100644 --- a/NumLib/Fem/ShapeMatrixPolicy.h +++ b/NumLib/Fem/ShapeMatrixPolicy.h @@ -54,7 +54,7 @@ struct EigenMatrixType<0, 1> /// An implementation of ShapeMatrixPolicy using fixed size (compile-time) eigen /// matrices and vectors. -template <typename ShapeFunction, unsigned GlobalDim> +template <typename ShapeFunction, int GlobalDim> struct EigenFixedShapeMatrixPolicy { template <int N> @@ -85,7 +85,7 @@ struct EigenFixedShapeMatrixPolicy /// An implementation of ShapeMatrixPolicy using dynamic size eigen matrices and /// vectors. -template <typename ShapeFunction, unsigned GlobalDim> +template <typename ShapeFunction, int GlobalDim> struct EigenDynamicShapeMatrixPolicy { // Dynamic size local matrices are much slower in allocation than their @@ -116,13 +116,13 @@ struct EigenDynamicShapeMatrixPolicy }; #ifdef OGS_EIGEN_DYNAMIC_SHAPE_MATRICES -template <typename ShapeFunction, unsigned GlobalDim> +template <typename ShapeFunction, int GlobalDim> using ShapeMatrixPolicyType = EigenDynamicShapeMatrixPolicy<ShapeFunction, GlobalDim>; const unsigned OGS_EIGEN_DYNAMIC_SHAPE_MATRICES_FLAG = 1; #else -template <typename ShapeFunction, unsigned GlobalDim> +template <typename ShapeFunction, int GlobalDim> using ShapeMatrixPolicyType = EigenFixedShapeMatrixPolicy<ShapeFunction, GlobalDim>; diff --git a/ProcessLib/BoundaryCondition/ConstraintDirichletBoundaryConditionLocalAssembler.h b/ProcessLib/BoundaryCondition/ConstraintDirichletBoundaryConditionLocalAssembler.h index b800a0e251a..3cdf60405a9 100644 --- a/ProcessLib/BoundaryCondition/ConstraintDirichletBoundaryConditionLocalAssembler.h +++ b/ProcessLib/BoundaryCondition/ConstraintDirichletBoundaryConditionLocalAssembler.h @@ -53,8 +53,7 @@ public: std::vector<GlobalVector*> const&)> const& getFlux) = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class ConstraintDirichletBoundaryConditionLocalAssembler final : public ConstraintDirichletBoundaryConditionLocalAssemblerInterface { diff --git a/ProcessLib/BoundaryCondition/GenericNaturalBoundaryCondition-impl.h b/ProcessLib/BoundaryCondition/GenericNaturalBoundaryCondition-impl.h index 08f084e39a5..0c91154d7c2 100644 --- a/ProcessLib/BoundaryCondition/GenericNaturalBoundaryCondition-impl.h +++ b/ProcessLib/BoundaryCondition/GenericNaturalBoundaryCondition-impl.h @@ -14,8 +14,7 @@ namespace ProcessLib { template <typename BoundaryConditionData, - template <typename, typename, unsigned> - class LocalAssemblerImplementation> + template <typename, typename, int> class LocalAssemblerImplementation> template <typename Data> GenericNaturalBoundaryCondition<BoundaryConditionData, LocalAssemblerImplementation>:: @@ -73,8 +72,7 @@ GenericNaturalBoundaryCondition<BoundaryConditionData, } template <typename BoundaryConditionData, - template <typename, typename, unsigned> - class LocalAssemblerImplementation> + template <typename, typename, int> class LocalAssemblerImplementation> void GenericNaturalBoundaryCondition<BoundaryConditionData, LocalAssemblerImplementation>:: applyNaturalBC(const double t, diff --git a/ProcessLib/BoundaryCondition/GenericNaturalBoundaryCondition.h b/ProcessLib/BoundaryCondition/GenericNaturalBoundaryCondition.h index 3012a3ae024..8d7a143ff1d 100644 --- a/ProcessLib/BoundaryCondition/GenericNaturalBoundaryCondition.h +++ b/ProcessLib/BoundaryCondition/GenericNaturalBoundaryCondition.h @@ -18,8 +18,7 @@ namespace ProcessLib class GenericNaturalBoundaryConditionLocalAssemblerInterface; template <typename BoundaryConditionData, - template <typename, typename, unsigned> - class LocalAssemblerImplementation> + template <typename, typename, int> class LocalAssemblerImplementation> class GenericNaturalBoundaryCondition final : public BoundaryCondition { public: diff --git a/ProcessLib/BoundaryCondition/GenericNaturalBoundaryConditionLocalAssembler.h b/ProcessLib/BoundaryCondition/GenericNaturalBoundaryConditionLocalAssembler.h index 5322d2c1f8e..a77507d6e65 100644 --- a/ProcessLib/BoundaryCondition/GenericNaturalBoundaryConditionLocalAssembler.h +++ b/ProcessLib/BoundaryCondition/GenericNaturalBoundaryConditionLocalAssembler.h @@ -29,8 +29,7 @@ public: GlobalMatrix& K, GlobalVector& b, GlobalMatrix* Jac) = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class GenericNaturalBoundaryConditionLocalAssembler : public GenericNaturalBoundaryConditionLocalAssemblerInterface { diff --git a/ProcessLib/BoundaryCondition/HCNonAdvectiveFreeComponentFlowBoundaryConditionLocalAssembler.h b/ProcessLib/BoundaryCondition/HCNonAdvectiveFreeComponentFlowBoundaryConditionLocalAssembler.h index 604422cbb5f..a3573b6bc3b 100644 --- a/ProcessLib/BoundaryCondition/HCNonAdvectiveFreeComponentFlowBoundaryConditionLocalAssembler.h +++ b/ProcessLib/BoundaryCondition/HCNonAdvectiveFreeComponentFlowBoundaryConditionLocalAssembler.h @@ -28,8 +28,7 @@ struct HCNonAdvectiveFreeComponentFlowBoundaryConditionData Process const& process; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class HCNonAdvectiveFreeComponentFlowBoundaryConditionLocalAssembler final : public GenericNaturalBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim> diff --git a/ProcessLib/BoundaryCondition/NeumannBoundaryConditionLocalAssembler.h b/ProcessLib/BoundaryCondition/NeumannBoundaryConditionLocalAssembler.h index 11bf2f6e97f..4e03fd79390 100644 --- a/ProcessLib/BoundaryCondition/NeumannBoundaryConditionLocalAssembler.h +++ b/ProcessLib/BoundaryCondition/NeumannBoundaryConditionLocalAssembler.h @@ -24,8 +24,7 @@ struct NeumannBoundaryConditionData final ParameterLib::Parameter<double> const* const integral_measure; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class NeumannBoundaryConditionLocalAssembler final : public GenericNaturalBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim> diff --git a/ProcessLib/BoundaryCondition/NormalTractionBoundaryCondition-impl.h b/ProcessLib/BoundaryCondition/NormalTractionBoundaryCondition-impl.h index b3eead1b9d1..28706ab75f2 100644 --- a/ProcessLib/BoundaryCondition/NormalTractionBoundaryCondition-impl.h +++ b/ProcessLib/BoundaryCondition/NormalTractionBoundaryCondition-impl.h @@ -22,8 +22,8 @@ namespace ProcessLib { namespace NormalTractionBoundaryCondition { -template <int GlobalDim, template <typename, typename, unsigned> - class LocalAssemblerImplementation> +template <int GlobalDim, + template <typename, typename, int> class LocalAssemblerImplementation> NormalTractionBoundaryCondition<GlobalDim, LocalAssemblerImplementation>:: NormalTractionBoundaryCondition( unsigned const integration_order, unsigned const shapefunction_order, @@ -58,8 +58,8 @@ NormalTractionBoundaryCondition<GlobalDim, LocalAssemblerImplementation>:: _pressure); } -template <int GlobalDim, template <typename, typename, unsigned> - class LocalAssemblerImplementation> +template <int GlobalDim, + template <typename, typename, int> class LocalAssemblerImplementation> void NormalTractionBoundaryCondition<GlobalDim, LocalAssemblerImplementation>:: applyNaturalBC(const double t, std::vector<GlobalVector*> const& x, int const /*process_id*/, GlobalMatrix& K, GlobalVector& b, diff --git a/ProcessLib/BoundaryCondition/NormalTractionBoundaryCondition.h b/ProcessLib/BoundaryCondition/NormalTractionBoundaryCondition.h index 9c831e943a6..de35f1db992 100644 --- a/ProcessLib/BoundaryCondition/NormalTractionBoundaryCondition.h +++ b/ProcessLib/BoundaryCondition/NormalTractionBoundaryCondition.h @@ -27,8 +27,8 @@ class NormalTractionBoundaryConditionLocalAssemblerInterface; /// \bar{t} := \sigma \mathbf{n} = p \mathbf{n}, /// \f] /// where \f$p\f$ is the value on the boundary given by the parameter tag. -template <int GlobalDim, template <typename, typename, unsigned> - class LocalAssemblerImplementation> +template <int GlobalDim, + template <typename, typename, int> class LocalAssemblerImplementation> class NormalTractionBoundaryCondition final : public BoundaryCondition { public: diff --git a/ProcessLib/BoundaryCondition/NormalTractionBoundaryConditionLocalAssembler.h b/ProcessLib/BoundaryCondition/NormalTractionBoundaryConditionLocalAssembler.h index 244393cf381..321cfed06b9 100644 --- a/ProcessLib/BoundaryCondition/NormalTractionBoundaryConditionLocalAssembler.h +++ b/ProcessLib/BoundaryCondition/NormalTractionBoundaryConditionLocalAssembler.h @@ -49,7 +49,7 @@ public: }; template <typename ShapeFunctionDisplacement, typename IntegrationMethod, - unsigned GlobalDim> + int GlobalDim> class NormalTractionBoundaryConditionLocalAssembler final : public NormalTractionBoundaryConditionLocalAssemblerInterface { @@ -96,7 +96,7 @@ public: else { auto const n = MeshLib::FaceRule::getSurfaceNormal(e).normalized(); - for (decltype(GlobalDim) i = 0; i < GlobalDim; ++i) + for (int i = 0; i < GlobalDim; ++i) { element_normal[i] = n[i]; } @@ -140,7 +140,7 @@ public: N_u = ShapeMatricesType::template MatrixType< GlobalDim, displacement_size>::Zero(GlobalDim, displacement_size); - for (int i = 0; i < static_cast<int>(GlobalDim); ++i) + for (int i = 0; i < GlobalDim; ++i) { N_u.template block<1, displacement_size / GlobalDim>( i, i * displacement_size / GlobalDim) diff --git a/ProcessLib/BoundaryCondition/Python/PythonBoundaryConditionLocalAssembler.h b/ProcessLib/BoundaryCondition/Python/PythonBoundaryConditionLocalAssembler.h index b14b5ddb0bf..9bbcf0b68ee 100644 --- a/ProcessLib/BoundaryCondition/Python/PythonBoundaryConditionLocalAssembler.h +++ b/ProcessLib/BoundaryCondition/Python/PythonBoundaryConditionLocalAssembler.h @@ -26,8 +26,7 @@ struct MethodNotOverriddenInDerivedClassException { }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class PythonBoundaryConditionLocalAssembler final : public GenericNaturalBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim> diff --git a/ProcessLib/BoundaryCondition/RobinBoundaryConditionLocalAssembler.h b/ProcessLib/BoundaryCondition/RobinBoundaryConditionLocalAssembler.h index 3698b84db5e..0d5cc6fe180 100644 --- a/ProcessLib/BoundaryCondition/RobinBoundaryConditionLocalAssembler.h +++ b/ProcessLib/BoundaryCondition/RobinBoundaryConditionLocalAssembler.h @@ -23,8 +23,7 @@ struct RobinBoundaryConditionData final ParameterLib::Parameter<double> const* const integral_measure; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class RobinBoundaryConditionLocalAssembler final : public GenericNaturalBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim> diff --git a/ProcessLib/BoundaryCondition/VariableDependentNeumannBoundaryConditionLocalAssembler.h b/ProcessLib/BoundaryCondition/VariableDependentNeumannBoundaryConditionLocalAssembler.h index bb8f037dfda..0f7d9c6c73b 100644 --- a/ProcessLib/BoundaryCondition/VariableDependentNeumannBoundaryConditionLocalAssembler.h +++ b/ProcessLib/BoundaryCondition/VariableDependentNeumannBoundaryConditionLocalAssembler.h @@ -29,8 +29,7 @@ struct VariableDependentNeumannBoundaryConditionData NumLib::LocalToGlobalIndexMap const& dof_table_boundary_other_variable; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class VariableDependentNeumannBoundaryConditionLocalAssembler final : public GenericNaturalBoundaryConditionLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim> diff --git a/ProcessLib/ComponentTransport/ComponentTransportFEM.h b/ProcessLib/ComponentTransport/ComponentTransportFEM.h index e077617de0d..d90de33aadf 100644 --- a/ProcessLib/ComponentTransport/ComponentTransportFEM.h +++ b/ProcessLib/ComponentTransport/ComponentTransportFEM.h @@ -144,8 +144,7 @@ protected: CoupledSolutionsForStaggeredScheme* _coupled_solutions{nullptr}; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class LocalAssemblerData : public ComponentTransportLocalAssemblerInterface { // When monolithic scheme is adopted, nodal pressure and nodal concentration diff --git a/ProcessLib/Deformation/BMatrixPolicy.h b/ProcessLib/Deformation/BMatrixPolicy.h index aa6f46d8c92..678f89cff38 100644 --- a/ProcessLib/Deformation/BMatrixPolicy.h +++ b/ProcessLib/Deformation/BMatrixPolicy.h @@ -17,7 +17,7 @@ namespace ProcessLib { /// An implementation of B-Matrix policy using same matrix and vector types /// (fixed size or dynamic) as in the ShapeMatrixPolicyType. -template <typename ShapeFunction, unsigned DisplacementDim> +template <typename ShapeFunction, int DisplacementDim> class BMatrixPolicyType { private: diff --git a/ProcessLib/Deformation/GMatrixPolicy.h b/ProcessLib/Deformation/GMatrixPolicy.h index 6766d6c2fe8..e2e2e1b6c98 100644 --- a/ProcessLib/Deformation/GMatrixPolicy.h +++ b/ProcessLib/Deformation/GMatrixPolicy.h @@ -16,7 +16,7 @@ namespace ProcessLib { /// An implementation of G-Matrix policy using same matrix and vector types /// (fixed size or dynamic) as in the ShapeMatrixPolicyType. -template <typename ShapeFunction, unsigned DisplacementDim> +template <typename ShapeFunction, int DisplacementDim> class GMatrixPolicyType { private: diff --git a/ProcessLib/HT/HTFEM.h b/ProcessLib/HT/HTFEM.h index 669958c905f..ffc90385478 100644 --- a/ProcessLib/HT/HTFEM.h +++ b/ProcessLib/HT/HTFEM.h @@ -28,8 +28,7 @@ namespace ProcessLib { namespace HT { -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class HTFEM : public HTLocalAssemblerInterface { using ShapeMatricesType = ShapeMatrixPolicyType<ShapeFunction, GlobalDim>; diff --git a/ProcessLib/HT/MonolithicHTFEM.h b/ProcessLib/HT/MonolithicHTFEM.h index a3a1fabdf8a..e22aac35f8f 100644 --- a/ProcessLib/HT/MonolithicHTFEM.h +++ b/ProcessLib/HT/MonolithicHTFEM.h @@ -31,8 +31,7 @@ namespace HT { const unsigned NUM_NODAL_DOF = 2; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class MonolithicHTFEM : public HTFEM<ShapeFunction, IntegrationMethod, GlobalDim> { diff --git a/ProcessLib/HT/StaggeredHTFEM-impl.h b/ProcessLib/HT/StaggeredHTFEM-impl.h index f1d0d16480a..7d0f3f8c5b1 100644 --- a/ProcessLib/HT/StaggeredHTFEM-impl.h +++ b/ProcessLib/HT/StaggeredHTFEM-impl.h @@ -21,8 +21,7 @@ namespace ProcessLib { namespace HT { -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void StaggeredHTFEM<ShapeFunction, IntegrationMethod, GlobalDim>:: assembleForStaggeredScheme(double const t, double const dt, Eigen::VectorXd const& local_x, @@ -43,8 +42,7 @@ void StaggeredHTFEM<ShapeFunction, IntegrationMethod, GlobalDim>:: local_K_data, local_b_data); } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void StaggeredHTFEM<ShapeFunction, IntegrationMethod, GlobalDim>:: assembleHydraulicEquation(double const t, double const dt, Eigen::VectorXd const& local_x, @@ -177,8 +175,7 @@ void StaggeredHTFEM<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void StaggeredHTFEM<ShapeFunction, IntegrationMethod, GlobalDim>:: assembleHeatTransportEquation(double const t, double const dt, @@ -287,8 +284,7 @@ void StaggeredHTFEM<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> const& StaggeredHTFEM<ShapeFunction, IntegrationMethod, GlobalDim>:: getIntPtDarcyVelocity( diff --git a/ProcessLib/HT/StaggeredHTFEM.h b/ProcessLib/HT/StaggeredHTFEM.h index ba0e3a8b58f..440bf6b8baa 100644 --- a/ProcessLib/HT/StaggeredHTFEM.h +++ b/ProcessLib/HT/StaggeredHTFEM.h @@ -28,8 +28,7 @@ struct LocalCoupledSolutions; namespace HT { -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class StaggeredHTFEM : public HTFEM<ShapeFunction, IntegrationMethod, GlobalDim> { using ShapeMatricesType = ShapeMatrixPolicyType<ShapeFunction, GlobalDim>; diff --git a/ProcessLib/HeatConduction/HeatConductionFEM.h b/ProcessLib/HeatConduction/HeatConductionFEM.h index a36dbec1886..4463d66cce3 100644 --- a/ProcessLib/HeatConduction/HeatConductionFEM.h +++ b/ProcessLib/HeatConduction/HeatConductionFEM.h @@ -54,8 +54,7 @@ public: std::vector<double>& cache) const = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class LocalAssemblerData : public HeatConductionLocalAssemblerInterface { using ShapeMatricesType = ShapeMatrixPolicyType<ShapeFunction, GlobalDim>; @@ -271,7 +270,7 @@ public: // heat flux only computed for output. GlobalDimVectorType const heat_flux = -k * sm.dNdx * local_x; - for (unsigned d = 0; d < GlobalDim; ++d) + for (int d = 0; d < GlobalDim; ++d) { _heat_fluxes[d][ip] = heat_flux[d]; } diff --git a/ProcessLib/LIE/Common/HMatrixUtils.h b/ProcessLib/LIE/Common/HMatrixUtils.h index 8102ec3c04b..9524440b375 100644 --- a/ProcessLib/LIE/Common/HMatrixUtils.h +++ b/ProcessLib/LIE/Common/HMatrixUtils.h @@ -16,7 +16,7 @@ namespace ProcessLib { /// An implementation of H-Matrix policy using same matrix and vector types /// (fixed size or dynamic) as in the ShapeMatrixPolicyType. -template <typename ShapeFunction, unsigned DisplacementDim> +template <typename ShapeFunction, int DisplacementDim> class HMatrixPolicyType { private: @@ -58,7 +58,7 @@ void computeHMatrix(N_Type const& N, HMatrixType& H) H.setZero(); - for (unsigned j = 0; j < DisplacementDim; j++) + for (int j = 0; j < DisplacementDim; j++) { H.block(j, j * NPOINTS, 1, NPOINTS) = N; } diff --git a/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.cpp b/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.cpp index 730ae72a42e..3903f7fc126 100644 --- a/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.cpp +++ b/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.cpp @@ -28,7 +28,7 @@ namespace LIE { namespace HydroMechanics { -template <unsigned GlobalDim> +template <int GlobalDim> std::unique_ptr<Process> createHydroMechanicsProcess( std::string name, MeshLib::Mesh& mesh, diff --git a/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.h b/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.h index b1f99ca8c11..1e438d7459d 100644 --- a/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.h +++ b/ProcessLib/LIE/HydroMechanics/CreateHydroMechanicsProcess.h @@ -41,7 +41,7 @@ namespace LIE { namespace HydroMechanics { -template <unsigned GlobalDim> +template <int GlobalDim> std::unique_ptr<Process> createHydroMechanicsProcess( std::string name, MeshLib::Mesh& mesh, diff --git a/ProcessLib/LIE/HydroMechanics/HydroMechanicsProcessData.h b/ProcessLib/LIE/HydroMechanics/HydroMechanicsProcessData.h index 22dda955562..a6a1b68004d 100644 --- a/ProcessLib/LIE/HydroMechanics/HydroMechanicsProcessData.h +++ b/ProcessLib/LIE/HydroMechanics/HydroMechanicsProcessData.h @@ -33,7 +33,7 @@ namespace LIE { namespace HydroMechanics { -template <unsigned GlobalDim> +template <int GlobalDim> struct HydroMechanicsProcessData { HydroMechanicsProcessData( diff --git a/ProcessLib/LIE/HydroMechanics/LocalAssembler/IntegrationPointDataFracture.h b/ProcessLib/LIE/HydroMechanics/LocalAssembler/IntegrationPointDataFracture.h index a2723df36ec..74100988bed 100644 --- a/ProcessLib/LIE/HydroMechanics/LocalAssembler/IntegrationPointDataFracture.h +++ b/ProcessLib/LIE/HydroMechanics/LocalAssembler/IntegrationPointDataFracture.h @@ -21,7 +21,7 @@ namespace LIE namespace HydroMechanics { template <typename HMatricesType, typename ShapeMatrixTypeDisplacement, - typename ShapeMatrixTypePressure, unsigned GlobalDim> + typename ShapeMatrixTypePressure, int GlobalDim> struct IntegrationPointDataFracture final { explicit IntegrationPointDataFracture( diff --git a/ProcessLib/LIE/HydroMechanics/LocalAssembler/IntegrationPointDataMatrix.h b/ProcessLib/LIE/HydroMechanics/LocalAssembler/IntegrationPointDataMatrix.h index e48f8aa7645..30049557495 100644 --- a/ProcessLib/LIE/HydroMechanics/LocalAssembler/IntegrationPointDataMatrix.h +++ b/ProcessLib/LIE/HydroMechanics/LocalAssembler/IntegrationPointDataMatrix.h @@ -22,8 +22,7 @@ namespace LIE namespace HydroMechanics { template <typename BMatricesType, typename ShapeMatrixTypeDisplacement, - typename ShapeMatrixTypePressure, unsigned GlobalDim, - unsigned NPoints> + typename ShapeMatrixTypePressure, int GlobalDim, unsigned NPoints> struct IntegrationPointDataMatrix final { explicit IntegrationPointDataMatrix( diff --git a/ProcessLib/LiquidFlow/LiquidFlowLocalAssembler-impl.h b/ProcessLib/LiquidFlow/LiquidFlowLocalAssembler-impl.h index 8699b0ec8dd..6fd74040b50 100644 --- a/ProcessLib/LiquidFlow/LiquidFlowLocalAssembler-impl.h +++ b/ProcessLib/LiquidFlow/LiquidFlowLocalAssembler-impl.h @@ -23,8 +23,7 @@ namespace ProcessLib { namespace LiquidFlow { -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: assemble(double const t, double const dt, std::vector<double> const& local_x, @@ -63,8 +62,7 @@ void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> Eigen::Vector3d LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>::getFlux( MathLib::Point3d const& p_local_coords, double const t, @@ -112,8 +110,7 @@ LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>::getFlux( return flux; } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> template <typename LaplacianGravityVelocityCalculator> void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: assembleMatrixAndVector(double const t, double const dt, @@ -195,8 +192,7 @@ void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> const& LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: getIntPtDarcyVelocity( @@ -251,8 +247,7 @@ LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: return velocity_cache; } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> template <typename LaplacianGravityVelocityCalculator> void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: computeDarcyVelocityLocal( @@ -303,8 +298,7 @@ void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: IsotropicCalculator::calculateLaplacianAndGravityTerm( Eigen::Map<NodalMatrixType>& local_K, @@ -325,8 +319,7 @@ void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: IsotropicCalculator::calculateVelocity( unsigned const ip, Eigen::Map<const NodalVectorType> const& local_p, @@ -348,8 +341,7 @@ void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: AnisotropicCalculator::calculateLaplacianAndGravityTerm( Eigen::Map<NodalMatrixType>& local_K, @@ -370,8 +362,7 @@ void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void LiquidFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: AnisotropicCalculator::calculateVelocity( unsigned const ip, Eigen::Map<const NodalVectorType> const& local_p, diff --git a/ProcessLib/LiquidFlow/LiquidFlowLocalAssembler.h b/ProcessLib/LiquidFlow/LiquidFlowLocalAssembler.h index 1d163876b68..e71d88703f5 100644 --- a/ProcessLib/LiquidFlow/LiquidFlowLocalAssembler.h +++ b/ProcessLib/LiquidFlow/LiquidFlowLocalAssembler.h @@ -62,8 +62,7 @@ public: std::vector<double>& cache) const = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class LiquidFlowLocalAssembler : public LiquidFlowLocalAssemblerInterface { using ShapeMatricesType = ShapeMatrixPolicyType<ShapeFunction, GlobalDim>; diff --git a/ProcessLib/LocalAssemblerTraits.h b/ProcessLib/LocalAssemblerTraits.h index 531b61f1fc5..544f5dd9f9d 100644 --- a/ProcessLib/LocalAssemblerTraits.h +++ b/ProcessLib/LocalAssemblerTraits.h @@ -32,7 +32,7 @@ namespace detail * size will be determined at compile-time. * \tparam Dim global spatial dimension */ -template<typename ShpPol, unsigned NNodes, unsigned NodalDOF, unsigned Dim> +template <typename ShpPol, unsigned NNodes, unsigned NodalDOF, int Dim> struct LocalAssemblerTraitsFixed { private: @@ -182,16 +182,18 @@ public: #ifndef OGS_EIGEN_DYNAMIC_SHAPE_MATRICES -template<typename ShpPol, unsigned NNodes, unsigned NodalDOF, unsigned Dim> -using LocalAssemblerTraits = detail::LocalAssemblerTraitsFixed<ShpPol, NNodes, NodalDOF, Dim>; +template <typename ShpPol, unsigned NNodes, unsigned NodalDOF, int Dim> +using LocalAssemblerTraits = + detail::LocalAssemblerTraitsFixed<ShpPol, NNodes, NodalDOF, Dim>; static_assert(OGS_EIGEN_DYNAMIC_SHAPE_MATRICES_FLAG == 0, "Inconsistent use of the macro OGS_EIGEN_DYNAMIC_SHAPE_MATRICES." " Maybe you forgot to include some header file."); #else -template<typename ShpPol, unsigned NNodes, unsigned NodalDOF, unsigned Dim> -using LocalAssemblerTraits = detail::LocalAssemblerTraitsFixed<ShapeMatrixPolicyType<void, 0>, 0, 0, 0>; +template <typename ShpPol, unsigned NNodes, unsigned NodalDOF, int Dim> +using LocalAssemblerTraits = + detail::LocalAssemblerTraitsFixed<ShapeMatrixPolicyType<void, 0>, 0, 0, 0>; static_assert(OGS_EIGEN_DYNAMIC_SHAPE_MATRICES_FLAG == 1, "Inconsistent use of the macro OGS_EIGEN_DYNAMIC_SHAPE_MATRICES." diff --git a/ProcessLib/RichardsComponentTransport/RichardsComponentTransportFEM-impl.h b/ProcessLib/RichardsComponentTransport/RichardsComponentTransportFEM-impl.h index e91a1570565..15c0b8f4b7c 100644 --- a/ProcessLib/RichardsComponentTransport/RichardsComponentTransportFEM-impl.h +++ b/ProcessLib/RichardsComponentTransport/RichardsComponentTransportFEM-impl.h @@ -19,8 +19,7 @@ namespace ProcessLib { namespace RichardsComponentTransport { -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> LocalAssemblerData<ShapeFunction, IntegrationMethod, GlobalDim>:: LocalAssemblerData( MeshLib::Element const& element, @@ -60,8 +59,7 @@ LocalAssemblerData<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void LocalAssemblerData<ShapeFunction, IntegrationMethod, GlobalDim>::assemble( double const t, double const dt, std::vector<double> const& local_x, std::vector<double> const& /*local_xdot*/, @@ -231,8 +229,7 @@ void LocalAssemblerData<ShapeFunction, IntegrationMethod, GlobalDim>::assemble( } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> const& LocalAssemblerData<ShapeFunction, IntegrationMethod, GlobalDim>:: getIntPtDarcyVelocity( @@ -316,8 +313,7 @@ LocalAssemblerData<ShapeFunction, IntegrationMethod, GlobalDim>:: return cache; } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> Eigen::Map<const Eigen::RowVectorXd> LocalAssemblerData<ShapeFunction, IntegrationMethod, GlobalDim>::getShapeMatrix( const unsigned integration_point) const @@ -328,8 +324,7 @@ LocalAssemblerData<ShapeFunction, IntegrationMethod, GlobalDim>::getShapeMatrix( return Eigen::Map<const Eigen::RowVectorXd>(N.data(), N.size()); } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> const& LocalAssemblerData<ShapeFunction, IntegrationMethod, GlobalDim>:: getIntPtSaturation( diff --git a/ProcessLib/RichardsComponentTransport/RichardsComponentTransportFEM.h b/ProcessLib/RichardsComponentTransport/RichardsComponentTransportFEM.h index 530378796b3..bb4a9b1bd8b 100644 --- a/ProcessLib/RichardsComponentTransport/RichardsComponentTransportFEM.h +++ b/ProcessLib/RichardsComponentTransport/RichardsComponentTransportFEM.h @@ -72,8 +72,7 @@ public: std::vector<double>& cache) const = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class LocalAssemblerData : public RichardsComponentTransportLocalAssemblerInterface { diff --git a/ProcessLib/RichardsFlow/RichardsFlowFEM.h b/ProcessLib/RichardsFlow/RichardsFlowFEM.h index aa6250e2647..401101aff96 100644 --- a/ProcessLib/RichardsFlow/RichardsFlowFEM.h +++ b/ProcessLib/RichardsFlow/RichardsFlowFEM.h @@ -75,8 +75,7 @@ public: std::vector<double>& cache) const = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class LocalAssemblerData : public RichardsFlowLocalAssemblerInterface { using ShapeMatricesType = ShapeMatrixPolicyType<ShapeFunction, GlobalDim>; diff --git a/ProcessLib/SourceTerms/Python/PythonSourceTermLocalAssembler.h b/ProcessLib/SourceTerms/Python/PythonSourceTermLocalAssembler.h index e4b12a9e826..6626ce7e1cc 100644 --- a/ProcessLib/SourceTerms/Python/PythonSourceTermLocalAssembler.h +++ b/ProcessLib/SourceTerms/Python/PythonSourceTermLocalAssembler.h @@ -46,8 +46,7 @@ struct IntegrationPointData final EIGEN_MAKE_ALIGNED_OPERATOR_NEW; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class PythonSourceTermLocalAssembler final : public PythonSourceTermLocalAssemblerInterface { diff --git a/ProcessLib/SourceTerms/VolumetricSourceTermFEM.h b/ProcessLib/SourceTerms/VolumetricSourceTermFEM.h index 8f750e3bc13..584185f1a61 100644 --- a/ProcessLib/SourceTerms/VolumetricSourceTermFEM.h +++ b/ProcessLib/SourceTerms/VolumetricSourceTermFEM.h @@ -32,8 +32,7 @@ public: virtual ~VolumetricSourceTermLocalAssemblerInterface() = default; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class VolumetricSourceTermLocalAssembler final : public VolumetricSourceTermLocalAssemblerInterface { diff --git a/ProcessLib/SteadyStateDiffusion/SteadyStateDiffusionFEM.h b/ProcessLib/SteadyStateDiffusion/SteadyStateDiffusionFEM.h index 209ee4eb10a..9aec91470e5 100644 --- a/ProcessLib/SteadyStateDiffusion/SteadyStateDiffusionFEM.h +++ b/ProcessLib/SteadyStateDiffusion/SteadyStateDiffusionFEM.h @@ -45,8 +45,7 @@ public: std::vector<double>& cache) const = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class LocalAssemblerData : public SteadyStateDiffusionLocalAssemblerInterface { using ShapeMatricesType = ShapeMatrixPolicyType<ShapeFunction, GlobalDim>; diff --git a/ProcessLib/SurfaceFlux/SurfaceFluxLocalAssembler.h b/ProcessLib/SurfaceFlux/SurfaceFluxLocalAssembler.h index 7153a55973a..69aa70dbf58 100644 --- a/ProcessLib/SurfaceFlux/SurfaceFluxLocalAssembler.h +++ b/ProcessLib/SurfaceFlux/SurfaceFluxLocalAssembler.h @@ -37,8 +37,7 @@ public: std::vector<GlobalVector*> const&)>) = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class SurfaceFluxLocalAssembler final : public SurfaceFluxLocalAssemblerInterface { diff --git a/ProcessLib/TES/TESLocalAssembler-impl.h b/ProcessLib/TES/TESLocalAssembler-impl.h index e7ba4af719e..7300c529f6e 100644 --- a/ProcessLib/TES/TESLocalAssembler-impl.h +++ b/ProcessLib/TES/TESLocalAssembler-impl.h @@ -115,8 +115,7 @@ namespace ProcessLib { namespace TES { -template <typename ShapeFunction_, typename IntegrationMethod_, - unsigned GlobalDim> +template <typename ShapeFunction_, typename IntegrationMethod_, int GlobalDim> TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: TESLocalAssembler(MeshLib::Element const& e, std::size_t const /*local_matrix_size*/, @@ -132,8 +131,7 @@ TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: { } -template <typename ShapeFunction_, typename IntegrationMethod_, - unsigned GlobalDim> +template <typename ShapeFunction_, typename IntegrationMethod_, int GlobalDim> void TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>::assemble( double const /*t*/, double const /*dt*/, std::vector<double> const& local_x, std::vector<double> const& /*local_xdot*/, @@ -195,8 +193,7 @@ void TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>::assemble( } } -template <typename ShapeFunction_, typename IntegrationMethod_, - unsigned GlobalDim> +template <typename ShapeFunction_, typename IntegrationMethod_, int GlobalDim> std::vector<double> const& TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: getIntPtSolidDensity( @@ -208,8 +205,7 @@ TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: return _d.getData().solid_density; } -template <typename ShapeFunction_, typename IntegrationMethod_, - unsigned GlobalDim> +template <typename ShapeFunction_, typename IntegrationMethod_, int GlobalDim> std::vector<double> const& TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: getIntPtLoading( @@ -230,8 +226,7 @@ TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: return cache; } -template <typename ShapeFunction_, typename IntegrationMethod_, - unsigned GlobalDim> +template <typename ShapeFunction_, typename IntegrationMethod_, int GlobalDim> std::vector<double> const& TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: getIntPtReactionDampingFactor( @@ -248,8 +243,7 @@ TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: return cache; } -template <typename ShapeFunction_, typename IntegrationMethod_, - unsigned GlobalDim> +template <typename ShapeFunction_, typename IntegrationMethod_, int GlobalDim> std::vector<double> const& TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: getIntPtReactionRate( @@ -261,8 +255,7 @@ TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: return _d.getData().reaction_rate; } -template <typename ShapeFunction_, typename IntegrationMethod_, - unsigned GlobalDim> +template <typename ShapeFunction_, typename IntegrationMethod_, int GlobalDim> std::vector<double> const& TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: getIntPtDarcyVelocity( @@ -305,12 +298,10 @@ TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: return cache; } -template <typename ShapeFunction_, typename IntegrationMethod_, - unsigned GlobalDim> -bool TESLocalAssembler< - ShapeFunction_, IntegrationMethod_, - GlobalDim>::checkBounds(std::vector<double> const& local_x, - std::vector<double> const& local_x_prev_ts) +template <typename ShapeFunction_, typename IntegrationMethod_, int GlobalDim> +bool TESLocalAssembler<ShapeFunction_, IntegrationMethod_, GlobalDim>:: + checkBounds(std::vector<double> const& local_x, + std::vector<double> const& local_x_prev_ts) { return _d.getReactionAdaptor().checkBounds(local_x, local_x_prev_ts); } diff --git a/ProcessLib/TES/TESLocalAssembler.h b/ProcessLib/TES/TESLocalAssembler.h index f41cbcf06ee..04f3ee38c6b 100644 --- a/ProcessLib/TES/TESLocalAssembler.h +++ b/ProcessLib/TES/TESLocalAssembler.h @@ -64,10 +64,8 @@ public: std::vector<double>& cache) const = 0; }; -template <typename ShapeFunction_, typename IntegrationMethod_, - unsigned GlobalDim> -class TESLocalAssembler final - : public TESLocalAssemblerInterface +template <typename ShapeFunction_, typename IntegrationMethod_, int GlobalDim> +class TESLocalAssembler final : public TESLocalAssemblerInterface { public: using ShapeFunction = ShapeFunction_; diff --git a/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPLocalAssembler-impl.h b/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPLocalAssembler-impl.h index f2660af759c..f4ea75dd80e 100644 --- a/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPLocalAssembler-impl.h +++ b/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPLocalAssembler-impl.h @@ -54,8 +54,7 @@ namespace ProcessLib { namespace ThermalTwoPhaseFlowWithPP { -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void ThermalTwoPhaseFlowWithPPLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim>::assemble(double const t, double const /*dt*/, diff --git a/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPLocalAssembler.h b/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPLocalAssembler.h index 25e058e3b2d..0410ca2f1ff 100644 --- a/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPLocalAssembler.h +++ b/ProcessLib/ThermalTwoPhaseFlowWithPP/ThermalTwoPhaseFlowWithPPLocalAssembler.h @@ -73,8 +73,7 @@ public: std::vector<double>& cache) const = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class ThermalTwoPhaseFlowWithPPLocalAssembler : public ThermalTwoPhaseFlowWithPPLocalAssemblerInterface { diff --git a/ProcessLib/ThermoRichardsFlow/ThermoRichardsFlowFEM-impl.h b/ProcessLib/ThermoRichardsFlow/ThermoRichardsFlowFEM-impl.h index 255c0b12afe..d72f66e4438 100644 --- a/ProcessLib/ThermoRichardsFlow/ThermoRichardsFlowFEM-impl.h +++ b/ProcessLib/ThermoRichardsFlow/ThermoRichardsFlowFEM-impl.h @@ -30,8 +30,7 @@ namespace ProcessLib { namespace ThermoRichardsFlow { -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: ThermoRichardsFlowLocalAssembler( MeshLib::Element const& e, @@ -80,8 +79,7 @@ ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::size_t ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim>::setIPDataInitialConditions(std::string const& name, @@ -111,8 +109,7 @@ std::size_t ThermoRichardsFlowLocalAssembler< return 0; } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: setInitialConditionsConcrete(std::vector<double> const& local_x, @@ -157,8 +154,7 @@ void ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim>::assembleWithJacobian(double const t, double const dt, @@ -679,16 +675,15 @@ void ThermoRichardsFlowLocalAssembler< } } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim>::assemble(double const t, double const dt, - std::vector<double> const& local_x, - std::vector<double> const& local_xdot, - std::vector<double>& local_M_data, - std::vector<double>& local_K_data, - std::vector<double>& local_rhs_data) + std::vector<double> const& local_x, + std::vector<double> const& local_xdot, + std::vector<double>& local_M_data, + std::vector<double>& local_K_data, + std::vector<double>& local_rhs_data) { auto const local_matrix_dim = pressure_size + temperature_size; assert(local_x.size() == local_matrix_dim); @@ -1107,8 +1102,7 @@ void ThermoRichardsFlowLocalAssembler< } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> const& ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: getIntPtDarcyVelocity( @@ -1133,8 +1127,7 @@ ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: return cache; } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim>::getSaturation() const { @@ -1143,8 +1136,7 @@ std::vector<double> ThermoRichardsFlowLocalAssembler< return result; } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> const& ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: getIntPtSaturation( @@ -1157,8 +1149,7 @@ ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: _ip_data, &IpData::saturation, cache); } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim>::getPorosity() const { @@ -1167,8 +1158,7 @@ std::vector<double> ThermoRichardsFlowLocalAssembler< return result; } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> const& ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: getIntPtPorosity( @@ -1181,8 +1171,7 @@ ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: &IpData::porosity, cache); } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> std::vector<double> const& ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: getIntPtDryDensitySolid( @@ -1195,8 +1184,7 @@ ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: _ip_data, &IpData::dry_density_solid, cache); } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, GlobalDim>:: computeSecondaryVariableConcrete(double const t, double const dt, @@ -1339,8 +1327,7 @@ void ThermoRichardsFlowLocalAssembler<ShapeFunction, IntegrationMethod, (*_process_data.element_porosity)[_element.getID()] = porosity_avg; } -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> unsigned ThermoRichardsFlowLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim>::getNumberOfIntegrationPoints() const diff --git a/ProcessLib/ThermoRichardsFlow/ThermoRichardsFlowFEM.h b/ProcessLib/ThermoRichardsFlow/ThermoRichardsFlowFEM.h index 9330d99849b..e6530df5210 100644 --- a/ProcessLib/ThermoRichardsFlow/ThermoRichardsFlowFEM.h +++ b/ProcessLib/ThermoRichardsFlow/ThermoRichardsFlowFEM.h @@ -31,8 +31,7 @@ namespace ThermoRichardsFlow { namespace MPL = MaterialPropertyLib; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class ThermoRichardsFlowLocalAssembler : public LocalAssemblerInterface { public: diff --git a/ProcessLib/TwoPhaseFlowWithPP/TwoPhaseFlowWithPPLocalAssembler-impl.h b/ProcessLib/TwoPhaseFlowWithPP/TwoPhaseFlowWithPPLocalAssembler-impl.h index fa778769de1..c529ab67783 100644 --- a/ProcessLib/TwoPhaseFlowWithPP/TwoPhaseFlowWithPPLocalAssembler-impl.h +++ b/ProcessLib/TwoPhaseFlowWithPP/TwoPhaseFlowWithPPLocalAssembler-impl.h @@ -42,8 +42,7 @@ namespace TwoPhaseFlowWithPP { namespace MPL = MaterialPropertyLib; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void TwoPhaseFlowWithPPLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim>::assemble(double const t, double const dt, diff --git a/ProcessLib/TwoPhaseFlowWithPP/TwoPhaseFlowWithPPLocalAssembler.h b/ProcessLib/TwoPhaseFlowWithPP/TwoPhaseFlowWithPPLocalAssembler.h index 01755c14ecd..b6e3c15c766 100644 --- a/ProcessLib/TwoPhaseFlowWithPP/TwoPhaseFlowWithPPLocalAssembler.h +++ b/ProcessLib/TwoPhaseFlowWithPP/TwoPhaseFlowWithPPLocalAssembler.h @@ -68,8 +68,7 @@ public: std::vector<double>& cache) const = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class TwoPhaseFlowWithPPLocalAssembler : public TwoPhaseFlowWithPPLocalAssemblerInterface { diff --git a/ProcessLib/TwoPhaseFlowWithPrho/TwoPhaseFlowWithPrhoLocalAssembler-impl.h b/ProcessLib/TwoPhaseFlowWithPrho/TwoPhaseFlowWithPrhoLocalAssembler-impl.h index 5f04e95f03a..7c4cb211952 100644 --- a/ProcessLib/TwoPhaseFlowWithPrho/TwoPhaseFlowWithPrhoLocalAssembler-impl.h +++ b/ProcessLib/TwoPhaseFlowWithPrho/TwoPhaseFlowWithPrhoLocalAssembler-impl.h @@ -20,8 +20,7 @@ namespace ProcessLib { namespace TwoPhaseFlowWithPrho { -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> void TwoPhaseFlowWithPrhoLocalAssembler< ShapeFunction, IntegrationMethod, GlobalDim>::assemble(double const t, double const /*dt*/, diff --git a/ProcessLib/TwoPhaseFlowWithPrho/TwoPhaseFlowWithPrhoLocalAssembler.h b/ProcessLib/TwoPhaseFlowWithPrho/TwoPhaseFlowWithPrhoLocalAssembler.h index 8c9d3757b1c..8bac2c1b173 100644 --- a/ProcessLib/TwoPhaseFlowWithPrho/TwoPhaseFlowWithPrhoLocalAssembler.h +++ b/ProcessLib/TwoPhaseFlowWithPrho/TwoPhaseFlowWithPrhoLocalAssembler.h @@ -76,8 +76,7 @@ public: std::vector<double>& cache) const = 0; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class TwoPhaseFlowWithPrhoLocalAssembler : public TwoPhaseFlowWithPrhoLocalAssemblerInterface { diff --git a/ProcessLib/Utils/CreateLocalAssemblers.h b/ProcessLib/Utils/CreateLocalAssemblers.h index 0c5d827f77a..51d70c7885e 100644 --- a/ProcessLib/Utils/CreateLocalAssemblers.h +++ b/ProcessLib/Utils/CreateLocalAssemblers.h @@ -17,9 +17,8 @@ namespace ProcessLib { - -template <unsigned GlobalDim, template <typename, typename, unsigned> - class LocalAssemblerImplementation, +template <int GlobalDim, + template <typename, typename, int> class LocalAssemblerImplementation, typename LocalAssemblerInterface, typename... ExtraCtorArgs> void createLocalAssemblers( NumLib::LocalToGlobalIndexMap const& dof_table, @@ -60,8 +59,7 @@ void createLocalAssemblers( * The first two template parameters cannot be deduced from the arguments. * Therefore they always have to be provided manually. */ -template <template <typename, typename, unsigned> - class LocalAssemblerImplementation, +template <template <typename, typename, int> class LocalAssemblerImplementation, typename LocalAssemblerInterface, typename... ExtraCtorArgs> void createLocalAssemblers( const unsigned dimension, diff --git a/ProcessLib/Utils/LocalDataInitializer.h b/ProcessLib/Utils/LocalDataInitializer.h index 61823f9ff9a..52a3cf317a9 100644 --- a/ProcessLib/Utils/LocalDataInitializer.h +++ b/ProcessLib/Utils/LocalDataInitializer.h @@ -120,8 +120,8 @@ namespace ProcessLib /// For example for MeshLib::Quad a local assembler data with template argument /// NumLib::ShapeQuad4 is created. template <typename LocalAssemblerInterface, - template <typename, typename, unsigned> class LocalAssemblerData, - unsigned GlobalDim, typename... ConstructorArgs> + template <typename, typename, int> class LocalAssemblerData, + int GlobalDim, typename... ConstructorArgs> class LocalDataInitializer final { public: diff --git a/Tests/MathLib/TestGaussLegendreIntegration.cpp b/Tests/MathLib/TestGaussLegendreIntegration.cpp index 3e2587e570f..60e37487d45 100644 --- a/Tests/MathLib/TestGaussLegendreIntegration.cpp +++ b/Tests/MathLib/TestGaussLegendreIntegration.cpp @@ -58,8 +58,7 @@ public: virtual ~LocalAssemblerDataInterface() = default; }; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class LocalAssemblerData : public LocalAssemblerDataInterface { using ShapeMatricesType = ShapeMatrixPolicyType<ShapeFunction, GlobalDim>; diff --git a/Tests/NumLib/TestExtrapolation.cpp b/Tests/NumLib/TestExtrapolation.cpp index da29e8c40a5..2e1cce4e0e5 100644 --- a/Tests/NumLib/TestExtrapolation.cpp +++ b/Tests/NumLib/TestExtrapolation.cpp @@ -70,8 +70,7 @@ using IntegrationPointValuesMethod = std::vector<double> const& ( , std::vector<double>& /*cache*/) const; -template <typename ShapeFunction, typename IntegrationMethod, - unsigned GlobalDim> +template <typename ShapeFunction, typename IntegrationMethod, int GlobalDim> class LocalAssemblerData : public LocalAssemblerDataInterface { using ShapeMatricesType = ShapeMatrixPolicyType<ShapeFunction, GlobalDim>; diff --git a/Tests/NumLib/TestFe.cpp b/Tests/NumLib/TestFe.cpp index 7ef0ca7cd45..d59b40cfada 100644 --- a/Tests/NumLib/TestFe.cpp +++ b/Tests/NumLib/TestFe.cpp @@ -37,12 +37,11 @@ using namespace FeTestData; namespace { // test cases -template <class TestFeType_, - template <typename, unsigned> class ShapeMatrixPolicy_> +template <class TestFeType_, template <typename, int> class ShapeMatrixPolicy_> struct TestCase { using TestFeType = TestFeType_; - static const unsigned GlobalDim = TestFeType::global_dim; + static const int GlobalDim = TestFeType::global_dim; using ShapeMatrixTypes = ShapeMatrixPolicy_<typename TestFeType::ShapeFunction, GlobalDim>; template <typename X> diff --git a/Tests/NumLib/TestGradShapeFunction.cpp b/Tests/NumLib/TestGradShapeFunction.cpp index 5689bf1cf2f..f8ebb05efc9 100644 --- a/Tests/NumLib/TestGradShapeFunction.cpp +++ b/Tests/NumLib/TestGradShapeFunction.cpp @@ -49,12 +49,11 @@ using namespace FeTestData; namespace { // test cases -template <class TestFeType_, - template <typename, unsigned> class ShapeMatrixPolicy_> +template <class TestFeType_, template <typename, int> class ShapeMatrixPolicy_> struct TestCase { using TestFeType = TestFeType_; - static const unsigned GlobalDim = TestFeType::global_dim; + static const int GlobalDim = TestFeType::global_dim; using ShapeMatrixTypes = ShapeMatrixPolicy_<typename TestFeType::ShapeFunction, GlobalDim>; template <typename X> @@ -109,7 +108,7 @@ public: using ShapeMatrixPolicy = typename T::template ShapeMatrixPolicy<X>; using MeshElementType = typename TestFeType::MeshElementType; - static const unsigned dim = TestFeType::dim; + static const int dim = TestFeType::dim; static const unsigned e_nnodes = TestFeType::e_nnodes; static const unsigned n_sample_pt_order2 = TestFeType::n_sample_pt_order2; static const unsigned n_sample_pt_order3 = TestFeType::n_sample_pt_order3; @@ -158,7 +157,7 @@ public: }; // NumLibFemIsoTest template <class T> -const unsigned GradShapeFunctionTest<T>::dim; +const int GradShapeFunctionTest<T>::dim; template <class T> const unsigned GradShapeFunctionTest<T>::e_nnodes; -- GitLab