diff --git a/Applications/ApplicationsLib/ProjectData.cpp b/Applications/ApplicationsLib/ProjectData.cpp index faa16291ef1d36d57afa619b3ee2ae668a389fe3..e4ff5913c6a6eee165483282a8887265761645d3 100644 --- a/Applications/ApplicationsLib/ProjectData.cpp +++ b/Applications/ApplicationsLib/ProjectData.cpp @@ -81,6 +81,9 @@ #ifdef OGS_BUILD_PROCESS_SMALLDEFORMATION #include "ProcessLib/SmallDeformation/CreateSmallDeformationProcess.h" #endif +#ifdef OGS_BUILD_PROCESS_SMALLDEFORMATIONNONLOCAL +#include "ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.h" +#endif #ifdef OGS_BUILD_PROCESS_TES #include "ProcessLib/TES/CreateTESProcess.h" #endif @@ -530,6 +533,34 @@ void ProjectData::parseProcesses(BaseLib::ConfigTree const& processes_config, } else #endif +#ifdef OGS_BUILD_PROCESS_SMALLDEFORMATIONNONLOCAL + if (type == "SMALL_DEFORMATION_NONLOCAL") + { + switch (_mesh_vec[0]->getDimension()) + { + case 2: + process = ProcessLib::SmallDeformationNonlocal:: + createSmallDeformationNonlocalProcess<2>( + *_mesh_vec[0], std::move(jacobian_assembler), + _process_variables, _parameters, integration_order, + process_config); + break; + case 3: + process = ProcessLib::SmallDeformationNonlocal:: + createSmallDeformationNonlocalProcess<3>( + *_mesh_vec[0], std::move(jacobian_assembler), + _process_variables, _parameters, integration_order, + process_config); + break; + default: + OGS_FATAL( + "SMALL_DEFORMATION_NONLOCAL process does not support " + "given dimension %d", + _mesh_vec[0]->getDimension()); + } + } + else +#endif #ifdef OGS_BUILD_PROCESS_LIE if (type == "SMALL_DEFORMATION_WITH_LIE") { diff --git a/CMakeLists.txt b/CMakeLists.txt index a72111375c3854b6b44a890dbaa341152b597c74..6cee71c71463810957f7ffcdee16b727c1f3e357 100644 --- a/CMakeLists.txt +++ b/CMakeLists.txt @@ -98,6 +98,7 @@ set(ProcessesList RichardsFlow RichardsMechanics SmallDeformation + SmallDeformationNonlocal TES ThermalTwoPhaseFlowWithPP ThermoMechanicalPhaseField diff --git a/Documentation/ProjectFile/material/solid/constitutive_relation/Ehlers/t_tangent_type.md b/Documentation/ProjectFile/material/solid/constitutive_relation/Ehlers/t_tangent_type.md new file mode 100644 index 0000000000000000000000000000000000000000..4966a2de9a2557f9946c10b2aa256e67dd50e51c --- /dev/null +++ b/Documentation/ProjectFile/material/solid/constitutive_relation/Ehlers/t_tangent_type.md @@ -0,0 +1,7 @@ +Defines which tangent operator is taken for the local "integrate stress" algorithm. + +Possible choices are: +Plastic -- default case (elasto-plastic operator) as in original Ehlers material + model. +Elastic -- purely elastic stiffness matrix +PlasticSecant -- damage secant elasto-plastic operator. diff --git a/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/c_SMALL_DEFORMATION_NONLOCAL.md b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/c_SMALL_DEFORMATION_NONLOCAL.md new file mode 100644 index 0000000000000000000000000000000000000000..67fce5b4bd25825e2be9d114d26c88f3163a476e --- /dev/null +++ b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/c_SMALL_DEFORMATION_NONLOCAL.md @@ -0,0 +1,4 @@ +Deformation process with linear kinematics enriched with non-local averaging +(integral) of internal variables. +Current implementation covers damage variable from the Ehlers material model +only. diff --git a/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/constitutive_relation b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/constitutive_relation new file mode 120000 index 0000000000000000000000000000000000000000..cfcb5e03bbe20c629c87a7f4d1fb7ac0fea2e1d3 --- /dev/null +++ b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/constitutive_relation @@ -0,0 +1 @@ +../../../../material/solid/constitutive_relation \ No newline at end of file diff --git a/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/process_variables/i_process_variables.md b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/process_variables/i_process_variables.md new file mode 100644 index 0000000000000000000000000000000000000000..e69de29bb2d1d6434b8b29ae775ad8c2e48c5391 diff --git a/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/process_variables/t_process_variable.md b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/process_variables/t_process_variable.md new file mode 100644 index 0000000000000000000000000000000000000000..d55b23cfca71ac3eb31c4c3b9567e340783c8fa2 --- /dev/null +++ b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/process_variables/t_process_variable.md @@ -0,0 +1 @@ +The displacement vector field. diff --git a/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_internal_length.md b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_internal_length.md new file mode 100644 index 0000000000000000000000000000000000000000..53cf112a686d148484d9c28b10b219364eeedf6d --- /dev/null +++ b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_internal_length.md @@ -0,0 +1 @@ +Internal length of non-local averaging scheme. diff --git a/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_reference_temperature.md b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_reference_temperature.md new file mode 100644 index 0000000000000000000000000000000000000000..ce255b04b7954788eb839b536e39a8f146dc9f1d --- /dev/null +++ b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_reference_temperature.md @@ -0,0 +1 @@ +Reference temperature, an optional input. diff --git a/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_solid_density.md b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_solid_density.md new file mode 100644 index 0000000000000000000000000000000000000000..4cc76c579164f400870a8eb0ac4d6c8d58e2c13e --- /dev/null +++ b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_solid_density.md @@ -0,0 +1 @@ +\copydoc ProcessLib::SmallDeformation::SmallDeformationProcessData::solid_density diff --git a/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_specific_body_force.md b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_specific_body_force.md new file mode 100644 index 0000000000000000000000000000000000000000..a481e852d81314336ca7ec474924e2763c2209d3 --- /dev/null +++ b/Documentation/ProjectFile/prj/processes/process/SMALL_DEFORMATION_NONLOCAL/t_specific_body_force.md @@ -0,0 +1 @@ +\copydoc ProcessLib::SmallDeformation::SmallDeformationProcessData::specific_body_force diff --git a/MaterialLib/SolidModels/CreateEhlers.h b/MaterialLib/SolidModels/CreateEhlers.h index 7d181c1d85ec1439a4a23fdd277bfb80b959b8fa..405a51429ed1a3d5895977a8ff6e281f37524afe 100644 --- a/MaterialLib/SolidModels/CreateEhlers.h +++ b/MaterialLib/SolidModels/CreateEhlers.h @@ -148,6 +148,10 @@ std::unique_ptr<SolidEhlers<DisplacementDim>> createEhlers( DBUG("Use \'%s\' as gammap.", gammap.name.c_str()); + //! \ogs_file_param_special{material__solid__constitutive_relation__Ehlers__tangent_type} + auto tangent_type = + makeTangentType(config.getConfigParameter<std::string>("tangent_type")); + MaterialPropertiesParameters mp{ shear_modulus, bulk_modulus, alpha, beta, gamma, delta, eps, m, @@ -170,7 +174,10 @@ std::unique_ptr<SolidEhlers<DisplacementDim>> createEhlers( createNewtonRaphsonSolverParameters(config); return std::make_unique<SolidEhlers<DisplacementDim>>( - nonlinear_solver_parameters, mp, std::move(ehlers_damage_properties)); + nonlinear_solver_parameters, + mp, + std::move(ehlers_damage_properties), + tangent_type); } } // namespace Ehlers diff --git a/MaterialLib/SolidModels/Ehlers.cpp b/MaterialLib/SolidModels/Ehlers.cpp index 680dcb246a3b803223a561ec6589eec011e2a207..2cda03b5f9d2ec6f0171092093526a12cba008ac 100644 --- a/MaterialLib/SolidModels/Ehlers.cpp +++ b/MaterialLib/SolidModels/Ehlers.cpp @@ -9,9 +9,10 @@ #include "Ehlers.h" #include <boost/math/special_functions/pow.hpp> - #include "MathLib/LinAlg/Eigen/EigenMapTools.h" +#include "LinearElasticIsotropic.h" + /** * Common convenitions for naming: * x_D - deviatoric part of tensor x @@ -514,10 +515,8 @@ SolidEhlers<DisplacementDim>::integrateStress( calculateIsotropicHardening(mp.kappa, mp.hardening_coefficient, state.eps_p.eff)) < 0)) { - tangentStiffness.setZero(); - tangentStiffness.template topLeftCorner<3, 3>().setConstant( - mp.K - 2. / 3 * mp.G); - tangentStiffness.noalias() += 2 * mp.G * KelvinMatrix::Identity(); + tangentStiffness = elasticTangentStiffness<DisplacementDim>( + mp.K - 2. / 3 * mp.G, mp.G); } else { @@ -618,10 +617,30 @@ SolidEhlers<DisplacementDim>::integrateStress( dresidual_deps.template block<KelvinVectorSize, KelvinVectorSize>(0, 0) .noalias() = calculateDResidualDEps<DisplacementDim>(mp.K, mp.G); - tangentStiffness = - mp.G * - linear_solver.solve(-dresidual_deps) - .template block<KelvinVectorSize, KelvinVectorSize>(0, 0); + if (_tangent_type == TangentType::Elastic) + { + tangentStiffness = + elasticTangentStiffness<DisplacementDim>(mp.K, mp.G); + } + else if (_tangent_type == TangentType::Plastic || + _tangent_type == TangentType::PlasticDamageSecant) + { + tangentStiffness = + mp.G * + linear_solver.solve(-dresidual_deps) + .template block<KelvinVectorSize, KelvinVectorSize>(0, 0); + if (_tangent_type == TangentType::PlasticDamageSecant) + { + tangentStiffness *= 1 - state.damage.value(); + } + } + else + { + OGS_FATAL( + "Unimplemented tangent type behaviour for the tangent type " + "'%d'.", + _tangent_type); + } } KelvinVector sigma_final = mp.G * sigma; diff --git a/MaterialLib/SolidModels/Ehlers.h b/MaterialLib/SolidModels/Ehlers.h index 2958c1c94ed4150a3fb145091f9863c839d2538f..22575ca2ef39d686336f968a4211326c4b234787 100644 --- a/MaterialLib/SolidModels/Ehlers.h +++ b/MaterialLib/SolidModels/Ehlers.h @@ -35,6 +35,24 @@ namespace Solids { namespace Ehlers { +enum class TangentType +{ + Elastic, + PlasticDamageSecant, + Plastic +}; +inline TangentType makeTangentType(std::string const& s) +{ + if (s == "Elastic") + return TangentType::Elastic; + if (s == "PlasticDamageSecant") + return TangentType::PlasticDamageSecant; + if (s == "Plastic") + return TangentType::Plastic; + OGS_FATAL("Not valid string '%s' to create a tangent type from.", + s.c_str()); +} + /// material parameters in relation to Ehler's single-surface model see Ehler's /// paper "A single-surface yield function for geomaterials" for more details /// \cite Ehlers1995. @@ -282,10 +300,12 @@ public: explicit SolidEhlers( NumLib::NewtonRaphsonSolverParameters nonlinear_solver_parameters, MaterialPropertiesParameters material_properties, - std::unique_ptr<DamagePropertiesParameters>&& damage_properties) + std::unique_ptr<DamagePropertiesParameters>&& damage_properties, + TangentType tangent_type) : _nonlinear_solver_parameters(std::move(nonlinear_solver_parameters)), _mp(std::move(material_properties)), - _damage_properties(std::move(damage_properties)) + _damage_properties(std::move(damage_properties)), + _tangent_type(tangent_type) { } @@ -341,6 +361,7 @@ private: MaterialPropertiesParameters _mp; std::unique_ptr<DamagePropertiesParameters> _damage_properties; + TangentType const _tangent_type; }; extern template class SolidEhlers<2>; diff --git a/MaterialLib/SolidModels/LinearElasticIsotropic.cpp b/MaterialLib/SolidModels/LinearElasticIsotropic.cpp index e28133f1c425211b6c55bc8a9494df9d72286e1c..23ea50f6e273fdacda830b7e22a7a87cc22fcde9 100644 --- a/MaterialLib/SolidModels/LinearElasticIsotropic.cpp +++ b/MaterialLib/SolidModels/LinearElasticIsotropic.cpp @@ -47,12 +47,8 @@ LinearElasticIsotropic<DisplacementDim>::getElasticTensor( double const t, ProcessLib::SpatialPosition const& x, double const /*T*/) const { - KelvinMatrix C = KelvinMatrix::Zero(); - - C.template topLeftCorner<3, 3>().setConstant(_mp.lambda(t, x)); - C.noalias() += 2 * _mp.mu(t, x) * KelvinMatrix::Identity(); - - return C; + return elasticTangentStiffness<DisplacementDim>(_mp.lambda(t, x), + _mp.mu(t, x)); } template class LinearElasticIsotropic<2>; diff --git a/MaterialLib/SolidModels/LinearElasticIsotropic.h b/MaterialLib/SolidModels/LinearElasticIsotropic.h index 5e9271dc0192cb4a000497de952495ebbd183ad6..ae1d1db22eeee3dbe0f09773e2404bbd357edaf8 100644 --- a/MaterialLib/SolidModels/LinearElasticIsotropic.h +++ b/MaterialLib/SolidModels/LinearElasticIsotropic.h @@ -133,5 +133,20 @@ protected: extern template class LinearElasticIsotropic<2>; extern template class LinearElasticIsotropic<3>; +template <int DisplacementDim> +MathLib::KelvinVector::KelvinMatrixType<DisplacementDim> +elasticTangentStiffness(double const first_lame_parameter, + double const shear_modulus) +{ + using KelvinMatrix = + MathLib::KelvinVector::KelvinMatrixType<DisplacementDim>; + + KelvinMatrix tangentStiffness = KelvinMatrix::Zero(); + tangentStiffness.template topLeftCorner<3, 3>().setConstant( + first_lame_parameter); + tangentStiffness.noalias() += 2 * shear_modulus * KelvinMatrix::Identity(); + return tangentStiffness; +} + } // namespace Solids } // namespace MaterialLib diff --git a/MathLib/KelvinVector-impl.h b/MathLib/KelvinVector-impl.h index 5baca5d3eece4149d2043adb381e5153c51cf436..8424ca47e09bf67c94667e7e4980965638323b17 100644 --- a/MathLib/KelvinVector-impl.h +++ b/MathLib/KelvinVector-impl.h @@ -18,7 +18,7 @@ double Invariants<KelvinVectorSize>::equivalentStress( Eigen::Matrix<double, KelvinVectorSize, 1> const& deviatoric_v) { assert(std::abs(trace(deviatoric_v)) <= - 5e-14 * diagonal(deviatoric_v).norm()); + 2e-13 * diagonal(deviatoric_v).norm()); return std::sqrt(3 * J2(deviatoric_v)); } @@ -34,7 +34,7 @@ double Invariants<KelvinVectorSize>::J2( Eigen::Matrix<double, KelvinVectorSize, 1> const& deviatoric_v) { assert(std::abs(trace(deviatoric_v)) <= - 5e-14 * diagonal(deviatoric_v).norm()); + 2e-13 * diagonal(deviatoric_v).norm()); return 0.5 * deviatoric_v.transpose() * deviatoric_v; } @@ -45,7 +45,7 @@ double Invariants<KelvinVectorSize>::J3( Eigen::Matrix<double, KelvinVectorSize, 1> const& deviatoric_v) { assert(std::abs(trace(deviatoric_v)) <= - 5e-14 * diagonal(deviatoric_v).norm()); + 2e-13 * diagonal(deviatoric_v).norm()); return determinant(deviatoric_v); } diff --git a/MathLib/KelvinVector.cpp b/MathLib/KelvinVector.cpp index 0c6718ddb8f9b2d73b066ed5cf3420ab59d19240..1359f452a8da828e7910b629659470c4553ae52b 100644 --- a/MathLib/KelvinVector.cpp +++ b/MathLib/KelvinVector.cpp @@ -80,6 +80,32 @@ Eigen::Matrix<double, 3, 3> kelvinVectorToTensor( return m; } +template <> +Eigen::Matrix<double, 3, 3> kelvinVectorToTensor(Eigen::Matrix<double, + Eigen::Dynamic, + 1, + Eigen::ColMajor, + Eigen::Dynamic, + 1> const& v) +{ + if (v.size() == 4) + { + Eigen::Matrix<double, 4, 1, Eigen::ColMajor, 4, 1> v4; + v4 << v[0], v[1], v[2], v[3]; + return kelvinVectorToTensor(v4); + } + if (v.size() == 6) + { + Eigen::Matrix<double, 6, 1, Eigen::ColMajor, 6, 1> v6; + v6 << v[0], v[1], v[2], v[3], v[4], v[5]; + return kelvinVectorToTensor(v6); + } + OGS_FATAL( + "Conversion of dynamic Kelvin vector of size %d to a tensor is not " + "possible. Kelvin vector must be of size 4 or 6.", + v.size()); +} + template <> KelvinVectorType<2> tensorToKelvin<2>(Eigen::Matrix<double, 3, 3> const& m) { diff --git a/ProcessLib/Deformation/Divergence.h b/ProcessLib/Deformation/Divergence.h new file mode 100644 index 0000000000000000000000000000000000000000..adbc0ca42db01bbbfa8a25d587aa96400326ad44 --- /dev/null +++ b/ProcessLib/Deformation/Divergence.h @@ -0,0 +1,34 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +namespace ProcessLib +{ +namespace Deformation +{ +/// Divergence of displacement, the volumetric strain. +template <int DisplacementDim, int NPOINTS, typename DNDX_Type> +double divergence( + const Eigen::Ref<Eigen::Matrix<double, NPOINTS * DisplacementDim, 1> const>& + u, + DNDX_Type const& dNdx) +{ + double divergence = 0; + for (int i = 0; i < DisplacementDim; ++i) + { + divergence += dNdx.template block<1, NPOINTS>(i, 0) * + u.template segment<NPOINTS>(i * NPOINTS); + } + return divergence; +} +} // namespace Deformation +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/CMakeLists.txt b/ProcessLib/SmallDeformationNonlocal/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..f99ef53c547de078cdd9a0d49275a1a88629a72c --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/CMakeLists.txt @@ -0,0 +1,6 @@ +APPEND_SOURCE_FILES(SOURCES) + +add_library(SmallDeformationNonlocal ${SOURCES}) +target_link_libraries(SmallDeformationNonlocal PUBLIC ProcessLib) + +include(Tests.cmake) diff --git a/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.cpp b/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.cpp new file mode 100644 index 0000000000000000000000000000000000000000..775ed844a65d9bbb2b14b89df73f35a99f669114 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.cpp @@ -0,0 +1,141 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#include "CreateSmallDeformationNonlocalProcess.h" + +#include <cassert> + +#include "MaterialLib/SolidModels/CreateConstitutiveRelation.h" +#include "ProcessLib/Output/CreateSecondaryVariables.h" +#include "ProcessLib/Utils/ProcessUtils.h" + +#include "SmallDeformationNonlocalProcess.h" +#include "SmallDeformationNonlocalProcessData.h" + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +template <int DisplacementDim> +std::unique_ptr<Process> createSmallDeformationNonlocalProcess( + MeshLib::Mesh& mesh, + std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler, + std::vector<ProcessVariable> const& variables, + std::vector<std::unique_ptr<ParameterBase>> const& parameters, + unsigned const integration_order, + BaseLib::ConfigTree const& config) +{ + //! \ogs_file_param{prj__processes__process__type} + config.checkConfigParameter("type", "SMALL_DEFORMATION_NONLOCAL"); + DBUG("Create SmallDeformationNonlocalProcess."); + + // Process variable. + + //! \ogs_file_param{prj__processes__process__SMALL_DEFORMATION_NONLOCAL__process_variables} + auto const pv_config = config.getConfigSubtree("process_variables"); + + auto per_process_variables = findProcessVariables( + variables, pv_config, + {//! \ogs_file_param_special{prj__processes__process__SMALL_DEFORMATION_NONLOCAL__process_variables__process_variable} + "process_variable"}); + + DBUG("Associate displacement with process variable '%s'.", + per_process_variables.back().get().getName().c_str()); + + if (per_process_variables.back().get().getNumberOfComponents() != + DisplacementDim) + { + OGS_FATAL( + "Number of components of the process variable '%s' is different " + "from the displacement dimension: got %d, expected %d", + per_process_variables.back().get().getName().c_str(), + per_process_variables.back().get().getNumberOfComponents(), + DisplacementDim); + } + std::vector<std::vector<std::reference_wrapper<ProcessVariable>>> + process_variables; + process_variables.push_back(std::move(per_process_variables)); + + auto solid_constitutive_relations = + MaterialLib::Solids::createConstitutiveRelations<DisplacementDim>( + parameters, config); + + // Solid density + auto& solid_density = findParameter<double>( + config, + //! \ogs_file_param_special{prj__processes__process__SMALL_DEFORMATION_NONLOCAL__solid_density} + "solid_density", parameters, 1); + DBUG("Use '%s' as solid density parameter.", solid_density.name.c_str()); + + // Specific body force + Eigen::Matrix<double, DisplacementDim, 1> specific_body_force; + { + std::vector<double> const b = + //! \ogs_file_param{prj__processes__process__SMALL_DEFORMATION_NONLOCAL__specific_body_force} + config.getConfigParameter<std::vector<double>>( + "specific_body_force"); + if (b.size() != DisplacementDim) + OGS_FATAL( + "The size of the specific body force vector does not match the " + "displacement dimension. Vector size is %d, displacement " + "dimension is %d", + b.size(), DisplacementDim); + + std::copy_n(b.data(), b.size(), specific_body_force.data()); + } + + // Reference temperature + const auto& reference_temperature = + //! \ogs_file_param{prj__processes__process__SMALL_DEFORMATION_NONLOCAL__reference_temperature} + config.getConfigParameter<double>( + "reference_temperature", std::numeric_limits<double>::quiet_NaN()); + + auto const internal_length = + //! \ogs_file_param{prj__processes__process__SMALL_DEFORMATION_NONLOCAL__internal_length} + config.getConfigParameter<double>("internal_length"); + + SmallDeformationNonlocalProcessData<DisplacementDim> process_data{ + materialIDs(mesh), std::move(solid_constitutive_relations), + solid_density, specific_body_force, + reference_temperature, internal_length}; + + SecondaryVariableCollection secondary_variables; + + NumLib::NamedFunctionCaller named_function_caller( + {"SmallDeformationNonlocal_displacement"}); + + ProcessLib::createSecondaryVariables(config, secondary_variables, + named_function_caller); + + return std::make_unique<SmallDeformationNonlocalProcess<DisplacementDim>>( + mesh, std::move(jacobian_assembler), parameters, integration_order, + std::move(process_variables), std::move(process_data), + std::move(secondary_variables), std::move(named_function_caller)); +} + +template std::unique_ptr<Process> createSmallDeformationNonlocalProcess<2>( + MeshLib::Mesh& mesh, + std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler, + std::vector<ProcessVariable> const& variables, + std::vector<std::unique_ptr<ParameterBase>> const& parameters, + unsigned const integration_order, + BaseLib::ConfigTree const& config); + +template std::unique_ptr<Process> createSmallDeformationNonlocalProcess<3>( + MeshLib::Mesh& mesh, + std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler, + std::vector<ProcessVariable> const& variables, + std::vector<std::unique_ptr<ParameterBase>> const& parameters, + unsigned const integration_order, + BaseLib::ConfigTree const& config); + +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.h b/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.h new file mode 100644 index 0000000000000000000000000000000000000000..06e5723be1249911950b28f0ce1f82d8c0454ecc --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/CreateSmallDeformationNonlocalProcess.h @@ -0,0 +1,65 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +#include <memory> +#include <vector> + +namespace BaseLib +{ +class ConfigTree; +} +namespace MeshLib +{ +class Mesh; +} +namespace ProcessLib +{ +class AbstractJacobianAssembler; +struct ParameterBase; +class Process; +class ProcessVariable; +} // namespace ProcessLib + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +template <int DisplacementDim> +std::unique_ptr<Process> createSmallDeformationNonlocalProcess( + MeshLib::Mesh& mesh, + std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler, + std::vector<ProcessVariable> const& variables, + std::vector<std::unique_ptr<ParameterBase>> const& parameters, + unsigned const integration_order, + BaseLib::ConfigTree const& config); + +extern template std::unique_ptr<Process> +createSmallDeformationNonlocalProcess<2>( + MeshLib::Mesh& mesh, + std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler, + std::vector<ProcessVariable> const& variables, + std::vector<std::unique_ptr<ParameterBase>> const& parameters, + unsigned const integration_order, + BaseLib::ConfigTree const& config); + +extern template std::unique_ptr<Process> +createSmallDeformationNonlocalProcess<3>( + MeshLib::Mesh& mesh, + std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& jacobian_assembler, + std::vector<ProcessVariable> const& variables, + std::vector<std::unique_ptr<ParameterBase>> const& parameters, + unsigned const integration_order, + BaseLib::ConfigTree const& config); + +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/Damage.h b/ProcessLib/SmallDeformationNonlocal/Damage.h new file mode 100644 index 0000000000000000000000000000000000000000..487115ccc71ab449460a6b39a78ed5ec7486a853 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/Damage.h @@ -0,0 +1,78 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +#include <Eigen/Eigenvalues> +#include <logog/include/logog.hpp> + +#include "MaterialLib/SolidModels/Ehlers.h" + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +/// Computes the damage internal material variable explicitly based on the +/// results obtained from the local stress return algorithm. +inline double calculateDamage(double const kappa_d, double const alpha_d, + double const beta_d) +{ + double const damage = (1 - beta_d) * (1 - std::exp(-kappa_d / alpha_d)); + + if (damage < 0. || damage >= 1.) + { + OGS_FATAL("Damage value %g outside of [0,1) interval.", damage); + } + + return damage; +} + +template <int DisplacementDim, typename KelvinVectorType> +double calculateDamageKappaD( + double const eps_p_eff_diff, + KelvinVectorType const& sigma, + double const kappa_d_prev, + double const h_d, + MaterialLib::Solids::Ehlers::MaterialProperties const& mp) +{ + // Default case of the rate problem. Updated below if volumetric plastic + // strain rate is positive (dilatancy). + + // non-const for Eigen solver. + auto sigma_tensor = MathLib::KelvinVector::kelvinVectorToTensor(sigma); + + Eigen::EigenSolver<decltype(sigma_tensor)> eigen_solver(sigma_tensor); + auto const principal_stress = real(eigen_solver.eigenvalues().array()); + double const prod_stress = std::sqrt(principal_stress.square().sum()); + + // Brittleness decrease with confinement for the nonlinear flow rule. + // ATTENTION: For linear flow rule -> constant brittleness. + double const tensile_strength = + std::sqrt(3.0) * mp.kappa / (1 + std::sqrt(3.0) * mp.beta); + double const r_s = prod_stress / tensile_strength - 1.; + + // Compute normalizing strain. + double const x_s = [](double const h_d, double const r_s) { + if (r_s < 0) + { + return 1.; + } + if (r_s <= 1) + { + return 1. + h_d * r_s * r_s; + } + return 1. - 3 * h_d + 4 * h_d * std::sqrt(r_s); + }(h_d, r_s); + + return kappa_d_prev + eps_p_eff_diff / x_s; +} +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/IntegrationPointData.h b/ProcessLib/SmallDeformationNonlocal/IntegrationPointData.h new file mode 100644 index 0000000000000000000000000000000000000000..cd83bb19da69ccbcfe34c929044a6de5067034f7 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/IntegrationPointData.h @@ -0,0 +1,73 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +#include "IntegrationPointDataNonlocalInterface.h" +#include "MaterialLib/SolidModels/Ehlers.h" + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +template <typename BMatricesType, typename ShapeMatricesType, + int DisplacementDim> +struct IntegrationPointData final : public IntegrationPointDataNonlocalInterface +{ + explicit IntegrationPointData( + MaterialLib::Solids::Ehlers::SolidEhlers<DisplacementDim>& + solid_material) + : solid_material(solid_material), + material_state_variables( + solid_material.createMaterialStateVariables()) + { + auto const msv = + static_cast<typename MaterialLib::Solids::Ehlers::StateVariables< + DisplacementDim>&>(*material_state_variables); + + eps_p_V = &msv.eps_p.V; + eps_p_D_xx = &msv.eps_p.D[0]; + } + + typename BMatricesType::BMatrixType b_matrices; + typename BMatricesType::KelvinVectorType sigma, sigma_prev; + typename BMatricesType::KelvinVectorType eps, eps_prev; + double free_energy_density = 0; + double damage = 0; ///< isotropic damage + double damage_prev = 0; ///< \copydoc damage + double kappa_d_prev = 0; ///< \copydoc kappa_d + + MaterialLib::Solids::Ehlers::SolidEhlers<DisplacementDim>& solid_material; + std::unique_ptr<typename MaterialLib::Solids::MechanicsBase< + DisplacementDim>::MaterialStateVariables> + material_state_variables; + + typename BMatricesType::KelvinMatrixType C; + typename ShapeMatricesType::NodalRowVectorType N; + typename ShapeMatricesType::GlobalDimNodalMatrixType dNdx; + + double const* eps_p_V; // Used for the secondary variables output. + double const* eps_p_D_xx; // Used for the secondary variables output. + + void pushBackState() + { + eps_prev = eps; + sigma_prev = sigma; + damage_prev = damage; + kappa_d_prev = kappa_d; + material_state_variables->pushBackState(); + } + + EIGEN_MAKE_ALIGNED_OPERATOR_NEW; +}; + +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/IntegrationPointDataNonlocalInterface.h b/ProcessLib/SmallDeformationNonlocal/IntegrationPointDataNonlocalInterface.h new file mode 100644 index 0000000000000000000000000000000000000000..98a874bdda3015a33c7aeb1fc6eefc09db4da740 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/IntegrationPointDataNonlocalInterface.h @@ -0,0 +1,43 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +struct IntegrationPointDataNonlocalInterface; + +struct NonlocalIP final +{ + IntegrationPointDataNonlocalInterface* const ip_l_pointer; + double alpha_kl_times_w_l; + double distance2; ///< Squared distance to current integration point. +}; + +struct IntegrationPointDataNonlocalInterface +{ + virtual ~IntegrationPointDataNonlocalInterface() = default; + + std::vector<NonlocalIP> non_local_assemblers; + + double kappa_d = 0; ///< damage driving variable. + double integration_weight; + double nonlocal_internal_length; + Eigen::Vector3d coordinates; + bool active_self = false; + bool activated = false; + + EIGEN_MAKE_ALIGNED_OPERATOR_NEW; +}; +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/IntegrationPointWriter.h b/ProcessLib/SmallDeformationNonlocal/IntegrationPointWriter.h new file mode 100644 index 0000000000000000000000000000000000000000..18c911cb3f8ba96b93cc91d1a1aa7b20024759f8 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/IntegrationPointWriter.h @@ -0,0 +1,87 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +#include <vector> + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +struct SigmaIntegrationPointWriter final : public IntegrationPointWriter +{ + SigmaIntegrationPointWriter( + int const n_components, + int const integration_order, + std::function<std::vector<std::vector<double>>()> + callback) + : _callback(callback), + _integration_order(integration_order), + _n_components(n_components) + { + } + + int numberOfComponents() const override { return _n_components; } + int integrationOrder() const override { return _integration_order; } + + std::string name() const override + { + // TODO (naumov) remove ip suffix. Probably needs modification of the + // mesh properties, s.t. there is no "overlapping" with cell/point data. + // See getOrCreateMeshProperty. + return "sigma_ip"; + } + + std::vector<std::vector<double>> values() const override + { + return _callback(); + } + +private: + std::function<std::vector<std::vector<double>>()> _callback; + int const _integration_order; + int const _n_components; +}; + +struct KappaDIntegrationPointWriter final : public IntegrationPointWriter +{ + KappaDIntegrationPointWriter( + int const integration_order, + std::function<std::vector<std::vector<double>>()> + callback) + : _callback(callback), _integration_order(integration_order) + { + } + + int numberOfComponents() const override { return 1; } + int integrationOrder() const override { return _integration_order; } + + std::string name() const override + { + // TODO (naumov) remove ip suffix. Probably needs modification of the + // mesh properties, s.t. there is no "overlapping" with cell/point data. + // See getOrCreateMeshProperty. + return "kappa_d_ip"; + } + + std::vector<std::vector<double>> values() const override + { + return _callback(); + } + +private: + std::function<std::vector<std::vector<double>>()> _callback; + int const _integration_order; +}; + +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/LocalAssemblerInterface.h b/ProcessLib/SmallDeformationNonlocal/LocalAssemblerInterface.h new file mode 100644 index 0000000000000000000000000000000000000000..6cf49d7917cef2eeb60ea5be3a84b70fdb61c05c --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/LocalAssemblerInterface.h @@ -0,0 +1,104 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +#include <memory> +#include <vector> + +#include "NumLib/Extrapolation/ExtrapolatableElement.h" +#include "ProcessLib/LocalAssemblerInterface.h" + +#include "IntegrationPointDataNonlocalInterface.h" + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +template <int DisplacementDim> +struct SmallDeformationNonlocalLocalAssemblerInterface + : public ProcessLib::LocalAssemblerInterface, + public NumLib::ExtrapolatableElement +{ + virtual std::size_t setIPDataInitialConditions( + std::string const& name, double const* values, + int const integration_order) = 0; + + virtual void setIPDataInitialConditionsFromCellData( + std::string const& name, std::vector<double> const& value) = 0; + + virtual void computeCrackIntegral( + std::size_t mesh_item_id, + NumLib::LocalToGlobalIndexMap const& dof_table, GlobalVector const& x, + double& crack_volume) = 0; + + virtual std::vector<double> const& getIntPtEpsPV( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const = 0; + virtual std::vector<double> const& getIntPtEpsPDXX( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const = 0; + virtual std::vector<double> getKappaD() const = 0; + virtual std::vector<double> const& getIntPtDamage( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const = 0; + + virtual std::vector<double> const& getIntPtFreeEnergyDensity( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const = 0; + + virtual std::vector<double> getSigma() const = 0; + virtual std::vector<double> const& getIntPtSigma( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const = 0; + + virtual std::vector<double> const& getIntPtEpsilon( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const = 0; + + // TODO move to NumLib::ExtrapolatableElement + virtual unsigned getNumberOfIntegrationPoints() const = 0; + + virtual typename MaterialLib::Solids::MechanicsBase< + DisplacementDim>::MaterialStateVariables const& + getMaterialStateVariablesAt(int integration_point) const = 0; + + virtual std::vector<double> const& getNodalValues( + std::vector<double>& nodal_values) const = 0; + + virtual void nonlocal( + std::size_t const mesh_item_id, + std::vector<std::unique_ptr< + SmallDeformationNonlocalLocalAssemblerInterface>> const& + local_assemblers) = 0; + + virtual void getIntegrationPointCoordinates( + Eigen::Vector3d const& coords, + std::vector<double>& distances) const = 0; + + virtual IntegrationPointDataNonlocalInterface* getIPDataPtr( + int const ip) = 0; +}; + +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalFEM.h b/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalFEM.h new file mode 100644 index 0000000000000000000000000000000000000000..0d792388b8418f0f95be8d3c5d9d36c5a13bae53 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalFEM.h @@ -0,0 +1,869 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +#include <algorithm> +#include <limits> +#include <memory> +#include <vector> + +#include "MaterialLib/SolidModels/Ehlers.h" +#include "MaterialLib/SolidModels/SelectSolidConstitutiveRelation.h" +#include "MathLib/LinAlg/Eigen/EigenMapTools.h" +#include "MeshLib/findElementsWithinRadius.h" +#include "NumLib/Fem/FiniteElement/TemplateIsoparametric.h" +#include "NumLib/Fem/ShapeMatrixPolicy.h" +#include "NumLib/Function/Interpolation.h" +#include "ProcessLib/Deformation/BMatrixPolicy.h" +#include "ProcessLib/Deformation/Divergence.h" +#include "ProcessLib/Deformation/LinearBMatrix.h" +#include "ProcessLib/LocalAssemblerTraits.h" +#include "ProcessLib/Parameter/Parameter.h" +#include "ProcessLib/Utils/InitShapeMatrices.h" + +#include "Damage.h" +#include "IntegrationPointData.h" +#include "LocalAssemblerInterface.h" +#include "SmallDeformationNonlocalProcessData.h" + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +/// Used for the extrapolation of the integration point values. It is ordered +/// (and stored) by integration points. +template <typename ShapeMatrixType> +struct SecondaryData +{ + std::vector<ShapeMatrixType, Eigen::aligned_allocator<ShapeMatrixType>> N; +}; + +template <typename ShapeFunction, typename IntegrationMethod, + int DisplacementDim> +class SmallDeformationNonlocalLocalAssembler + : public SmallDeformationNonlocalLocalAssemblerInterface<DisplacementDim> +{ +public: + using ShapeMatricesType = + ShapeMatrixPolicyType<ShapeFunction, DisplacementDim>; + using NodalMatrixType = typename ShapeMatricesType::NodalMatrixType; + using NodalVectorType = typename ShapeMatricesType::NodalVectorType; + using GlobalDimVectorType = typename ShapeMatricesType::GlobalDimVectorType; + using ShapeMatrices = typename ShapeMatricesType::ShapeMatrices; + using BMatricesType = BMatrixPolicyType<ShapeFunction, DisplacementDim>; + + using BMatrixType = typename BMatricesType::BMatrixType; + using StiffnessMatrixType = typename BMatricesType::StiffnessMatrixType; + using NodalForceVectorType = typename BMatricesType::NodalForceVectorType; + using NodalDisplacementVectorType = + typename BMatricesType::NodalForceVectorType; + + SmallDeformationNonlocalLocalAssembler( + SmallDeformationNonlocalLocalAssembler const&) = delete; + SmallDeformationNonlocalLocalAssembler( + SmallDeformationNonlocalLocalAssembler&&) = delete; + + SmallDeformationNonlocalLocalAssembler( + MeshLib::Element const& e, + std::size_t const /*local_matrix_size*/, + bool const is_axially_symmetric, + unsigned const integration_order, + SmallDeformationNonlocalProcessData<DisplacementDim>& process_data) + : _process_data(process_data), + _integration_method(integration_order), + _element(e), + _is_axially_symmetric(is_axially_symmetric) + { + unsigned const n_integration_points = + _integration_method.getNumberOfPoints(); + + _ip_data.reserve(n_integration_points); + _secondary_data.N.resize(n_integration_points); + + auto const shape_matrices = + initShapeMatrices<ShapeFunction, ShapeMatricesType, + IntegrationMethod, DisplacementDim>( + e, is_axially_symmetric, _integration_method); + + auto& solid_material = + MaterialLib::Solids::selectSolidConstitutiveRelation( + _process_data.solid_materials, + _process_data.material_ids, + e.getID()); + auto* ehlers_solid_material = dynamic_cast< + MaterialLib::Solids::Ehlers::SolidEhlers<DisplacementDim>*>( + &solid_material); + if (ehlers_solid_material == nullptr) + { + OGS_FATAL( + "The SmallDeformationNonlocalLocal process supports only " + "Ehlers material at the moment. For other materials the " + "interface must be extended first."); + } + + for (unsigned ip = 0; ip < n_integration_points; ip++) + { + _ip_data.emplace_back(*ehlers_solid_material); + auto& ip_data = _ip_data[ip]; + auto const& sm = shape_matrices[ip]; + _ip_data[ip].integration_weight = + _integration_method.getWeightedPoint(ip).getWeight() * + sm.integralMeasure * sm.detJ; + + ip_data.N = sm.N; + ip_data.dNdx = sm.dNdx; + + // Initialize current time step values + ip_data.sigma.setZero(MathLib::KelvinVector::KelvinVectorDimensions< + DisplacementDim>::value); + ip_data.eps.setZero(MathLib::KelvinVector::KelvinVectorDimensions< + DisplacementDim>::value); + + // Previous time step values are not initialized and are set later. + ip_data.sigma_prev.resize( + MathLib::KelvinVector::KelvinVectorDimensions< + DisplacementDim>::value); + ip_data.eps_prev.resize( + MathLib::KelvinVector::KelvinVectorDimensions< + DisplacementDim>::value); + + _secondary_data.N[ip] = shape_matrices[ip].N; + + ip_data.coordinates = getSingleIntegrationPointCoordinates(ip); + } + } + + std::size_t setIPDataInitialConditions(std::string const& name, + double const* values, + int const integration_order) override + { + if (integration_order != + static_cast<int>(_integration_method.getIntegrationOrder())) + { + OGS_FATAL( + "Setting integration point initial conditions; The integration " + "order of the local assembler for element %d is different from " + "the integration order in the initial condition.", + _element.getID()); + } + + if (name == "sigma_ip") + { + return setSigma(values); + } + + if (name == "kappa_d_ip") + { + return setKappaD(values); + } + + return 0; + } + + void setIPDataInitialConditionsFromCellData( + std::string const& name, std::vector<double> const& value) override + { + if (name == "kappa_d_ip") + { + if (value.size() != 1) + { + OGS_FATAL( + "CellData for kappa_d initial conditions has wrong number " + "of components. 1 expected, got %d.", + value.size()); + } + setKappaD(value[0]); + } + } + + double alpha_0(double const distance2) const + { + double const internal_length2 = _process_data.internal_length_squared; + return (distance2 > internal_length2) + ? 0 + : (1 - distance2 / (internal_length2)) * + (1 - distance2 / (internal_length2)); + } + + void nonlocal( + std::size_t const /*mesh_item_id*/, + std::vector< + std::unique_ptr<SmallDeformationNonlocalLocalAssemblerInterface< + DisplacementDim>>> const& local_assemblers) override + { + auto const search_element_ids = MeshLib::findElementsWithinRadius( + _element, _process_data.internal_length_squared); + + unsigned const n_integration_points = + _integration_method.getNumberOfPoints(); + + std::vector<double> distances; // Cache for ip-ip distances. + // + // For every integration point in this element collect the neighbouring + // integration points falling in given radius (internal length) and + // compute the alpha_kl weight. + // + for (unsigned k = 0; k < n_integration_points; k++) + { + // + // Collect the integration points. + // + + auto const& xyz = _ip_data[k].coordinates; + + // For all neighbors of element + for (auto const search_element_id : search_element_ids) + { + auto const& la = local_assemblers[search_element_id]; + la->getIntegrationPointCoordinates(xyz, distances); + for (int ip = 0; ip < static_cast<int>(distances.size()); ++ip) + { + if (distances[ip] >= _process_data.internal_length_squared) + continue; + // save into current ip_k + _ip_data[k].non_local_assemblers.push_back( + {la->getIPDataPtr(ip), + std::numeric_limits<double>::quiet_NaN(), + distances[ip]}); + } + } + if (_ip_data[k].non_local_assemblers.size() == 0) + { + OGS_FATAL("no neighbours found!"); + } + + double a_k_sum_m = 0; + for (auto const& tuple : _ip_data[k].non_local_assemblers) + { + double const distance2_m = tuple.distance2; + + auto const& w_m = tuple.ip_l_pointer->integration_weight; + + a_k_sum_m += w_m * alpha_0(distance2_m); + } + + // + // Calculate alpha_kl = + // alpha_0(|x_k - x_l|) / int_{m \in ip} alpha_0(|x_k - x_m|) + // + for (auto& tuple : _ip_data[k].non_local_assemblers) + { + double const distance2_l = tuple.distance2; + double const a_kl = alpha_0(distance2_l) / a_k_sum_m; + + // Store the a_kl already multiplied with the integration + // weight of that l integration point. + auto const w_l = tuple.ip_l_pointer->integration_weight; + tuple.alpha_kl_times_w_l = a_kl * w_l; + } + } + } + + Eigen::Vector3d getSingleIntegrationPointCoordinates( + int integration_point) const + { + auto const& N = _secondary_data.N[integration_point]; + + Eigen::Vector3d xyz = Eigen::Vector3d::Zero(); // Resulting coordinates + auto* nodes = _element.getNodes(); + for (int i = 0; i < N.size(); ++i) + { + Eigen::Map<Eigen::Vector3d const> node_coordinates{ + nodes[i]->getCoords(), 3}; + xyz += node_coordinates * N[i]; + } + return xyz; + } + + /// For each of the current element's integration points the squared + /// distance from the current integration point is computed and stored in + /// the given distances cache. + void getIntegrationPointCoordinates( + Eigen::Vector3d const& coords, + std::vector<double>& distances) const override + { + unsigned const n_integration_points = + _integration_method.getNumberOfPoints(); + + distances.resize(n_integration_points); + + for (unsigned ip = 0; ip < n_integration_points; ip++) + { + auto const& xyz = _ip_data[ip].coordinates; + distances[ip] = (xyz - coords).squaredNorm(); + } + } + + void assemble(double const /*t*/, std::vector<double> const& /*local_x*/, + std::vector<double>& /*local_M_data*/, + std::vector<double>& /*local_K_data*/, + std::vector<double>& /*local_b_data*/) override + { + OGS_FATAL( + "SmallDeformationNonlocalLocalAssembler: assembly without jacobian " + "is not " + "implemented."); + } + + void preAssemble(double const t, + std::vector<double> const& local_x) override + { + auto const n_integration_points = + _integration_method.getNumberOfPoints(); + + SpatialPosition x_position; + x_position.setElementID(_element.getID()); + + for (unsigned ip = 0; ip < n_integration_points; ip++) + { + x_position.setIntegrationPoint(ip); + + auto const& N = _ip_data[ip].N; + auto const& dNdx = _ip_data[ip].dNdx; + + auto const x_coord = + interpolateXCoordinate<ShapeFunction, ShapeMatricesType>( + _element, N); + auto const B = LinearBMatrix::computeBMatrix< + DisplacementDim, ShapeFunction::NPOINTS, + typename BMatricesType::BMatrixType>(dNdx, N, x_coord, + _is_axially_symmetric); + auto const& eps_prev = _ip_data[ip].eps_prev; + auto const& sigma_prev = _ip_data[ip].sigma_prev; + + auto& eps = _ip_data[ip].eps; + auto& sigma = _ip_data[ip].sigma; + auto& C = _ip_data[ip].C; + auto& state = _ip_data[ip].material_state_variables; + double const& damage_prev = _ip_data[ip].damage_prev; + + eps.noalias() = + B * + Eigen::Map<typename BMatricesType::NodalForceVectorType const>( + local_x.data(), ShapeFunction::NPOINTS * DisplacementDim); + + // sigma is for plastic part only. + std::unique_ptr< + MathLib::KelvinVector::KelvinMatrixType<DisplacementDim>> + new_C; + std::unique_ptr<typename MaterialLib::Solids::MechanicsBase< + DisplacementDim>::MaterialStateVariables> + new_state; + + // Compute sigma_eff from damage total stress sigma + using KelvinVectorType = typename BMatricesType::KelvinVectorType; + KelvinVectorType const sigma_eff_prev = + sigma_prev / + (1. - damage_prev); // damage_prev is in [0,1) range. See + // calculateDamage() function. + + auto&& solution = _ip_data[ip].solid_material.integrateStress( + t, x_position, _process_data.dt, eps_prev, eps, sigma_eff_prev, + *state, _process_data.reference_temperature); + + if (!solution) + OGS_FATAL("Computation of local constitutive relation failed."); + + std::tie(sigma, state, C) = std::move(*solution); + + /// Compute only the local kappa_d. + { + auto const& ehlers_material = + static_cast<MaterialLib::Solids::Ehlers::SolidEhlers< + DisplacementDim> const&>(_ip_data[ip].solid_material); + auto const damage_properties = + ehlers_material.evaluatedDamageProperties(t, x_position); + auto const material_properties = + ehlers_material.evaluatedMaterialProperties(t, x_position); + + // Ehlers material state variables + auto& state_vars = + static_cast<MaterialLib::Solids::Ehlers::StateVariables< + DisplacementDim>&>( + *_ip_data[ip].material_state_variables); + + double const eps_p_eff_diff = + state_vars.eps_p.eff - state_vars.eps_p_prev.eff; + + _ip_data[ip].kappa_d = calculateDamageKappaD<DisplacementDim>( + eps_p_eff_diff, sigma, _ip_data[ip].kappa_d_prev, + damage_properties.h_d, material_properties); + + if (!_ip_data[ip].active_self) + { + _ip_data[ip].active_self |= _ip_data[ip].kappa_d > 0; + if (_ip_data[ip].active_self) + { + for (auto const& tuple : + _ip_data[ip].non_local_assemblers) + { + // Activate the integration point. + tuple.ip_l_pointer->activated = true; + } + } + } + } + } + } + + void assembleWithJacobian(double const t, + std::vector<double> const& local_x, + std::vector<double> const& /*local_xdot*/, + const double /*dxdot_dx*/, const double /*dx_dx*/, + std::vector<double>& /*local_M_data*/, + std::vector<double>& /*local_K_data*/, + std::vector<double>& local_b_data, + std::vector<double>& local_Jac_data) override + { + auto const local_matrix_size = local_x.size(); + + auto local_Jac = MathLib::createZeroedMatrix<StiffnessMatrixType>( + local_Jac_data, local_matrix_size, local_matrix_size); + + auto local_b = MathLib::createZeroedVector<NodalDisplacementVectorType>( + local_b_data, local_matrix_size); + + unsigned const n_integration_points = + _integration_method.getNumberOfPoints(); + + SpatialPosition x_position; + x_position.setElementID(_element.getID()); + + // Non-local integration. + for (unsigned ip = 0; ip < n_integration_points; ip++) + { + x_position.setIntegrationPoint(ip); + auto const& w = _ip_data[ip].integration_weight; + + auto const& N = _ip_data[ip].N; + auto const& dNdx = _ip_data[ip].dNdx; + + auto const x_coord = + interpolateXCoordinate<ShapeFunction, ShapeMatricesType>( + _element, N); + auto const B = LinearBMatrix::computeBMatrix< + DisplacementDim, ShapeFunction::NPOINTS, + typename BMatricesType::BMatrixType>(dNdx, N, x_coord, + _is_axially_symmetric); + + auto& sigma = _ip_data[ip].sigma; + auto& C = _ip_data[ip].C; + double& damage = _ip_data[ip].damage; + + { + double nonlocal_kappa_d = 0; + + if (_ip_data[ip].active_self || _ip_data[ip].activated) + { + for (auto const& tuple : _ip_data[ip].non_local_assemblers) + { + // Get local variable for the integration point l. + double const kappa_d_l = tuple.ip_l_pointer->kappa_d; + double const a_kl_times_w_l = tuple.alpha_kl_times_w_l; + nonlocal_kappa_d += a_kl_times_w_l * kappa_d_l; + } + } + + auto const& ehlers_material = + static_cast<MaterialLib::Solids::Ehlers::SolidEhlers< + DisplacementDim> const&>(_ip_data[ip].solid_material); + + // + // Overnonlocal formulation + // + // See (Di Luzio & Bazant 2005, IJSS) for details. + // The implementation would go here and would be for a given + // gamma_nonlocal: + // + // Update nonlocal damage with local damage (scaled with 1 - + // \gamma_{nonlocal}) for the current integration point and the + // nonlocal integral part. + // nonlocal_kappa_d = (1. - gamma_nonlocal) * kappa_d + + // gamma_nonlocal * nonlocal_kappa_d; + + nonlocal_kappa_d = std::max(0., nonlocal_kappa_d); + + // Update damage based on nonlocal kappa_d + { + auto const damage_properties = + ehlers_material.evaluatedDamageProperties(t, + x_position); + damage = calculateDamage(nonlocal_kappa_d, + damage_properties.alpha_d, + damage_properties.beta_d); + damage = std::max(0., damage); + } + sigma = sigma * (1. - damage); + } + + local_b.noalias() -= B.transpose() * sigma * w; + local_Jac.noalias() += B.transpose() * C * (1. - damage) * B * w; + } + } + + void preTimestepConcrete(std::vector<double> const& /*local_x*/, + double const /*t*/, + double const /*delta_t*/) override + { + unsigned const n_integration_points = + _integration_method.getNumberOfPoints(); + + for (unsigned ip = 0; ip < n_integration_points; ip++) + { + _ip_data[ip].pushBackState(); + } + } + + void computeCrackIntegral(std::size_t mesh_item_id, + NumLib::LocalToGlobalIndexMap const& dof_table, + GlobalVector const& x, + double& crack_volume) override + { + auto const indices = NumLib::getIndices(mesh_item_id, dof_table); + auto local_x = x.get(indices); + + auto u = Eigen::Map<typename BMatricesType::NodalForceVectorType const>( + local_x.data(), ShapeFunction::NPOINTS * DisplacementDim); + + int const n_integration_points = + _integration_method.getNumberOfPoints(); + + for (int ip = 0; ip < n_integration_points; ip++) + { + auto const& dNdx = _ip_data[ip].dNdx; + auto const& d = _ip_data[ip].damage; + auto const& w = _ip_data[ip].integration_weight; + + double const div_u = + Deformation::divergence<DisplacementDim, + ShapeFunction::NPOINTS>(u, dNdx); + crack_volume += div_u * d * w; + } + } + + Eigen::Map<const Eigen::RowVectorXd> getShapeMatrix( + const unsigned integration_point) const override + { + auto const& N = _secondary_data.N[integration_point]; + + // assumes N is stored contiguously in memory + return Eigen::Map<const Eigen::RowVectorXd>(N.data(), N.size()); + } + + std::vector<double> const& getNodalValues( + std::vector<double>& nodal_values) const override + { + nodal_values.clear(); + auto local_b = MathLib::createZeroedVector<NodalDisplacementVectorType>( + nodal_values, ShapeFunction::NPOINTS * DisplacementDim); + + unsigned const n_integration_points = + _integration_method.getNumberOfPoints(); + + for (unsigned ip = 0; ip < n_integration_points; ip++) + { + auto const& w = _ip_data[ip].integration_weight; + + auto const& N = _ip_data[ip].N; + auto const& dNdx = _ip_data[ip].dNdx; + + auto const x_coord = + interpolateXCoordinate<ShapeFunction, ShapeMatricesType>( + _element, N); + auto const B = LinearBMatrix::computeBMatrix< + DisplacementDim, ShapeFunction::NPOINTS, + typename BMatricesType::BMatrixType>(dNdx, N, x_coord, + _is_axially_symmetric); + auto& sigma = _ip_data[ip].sigma; + + local_b.noalias() += B.transpose() * sigma * w; + } + + return nodal_values; + } + + std::vector<double> const& getIntPtFreeEnergyDensity( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const override + { + cache.clear(); + cache.reserve(_ip_data.size()); + + for (auto const& ip_data : _ip_data) + { + cache.push_back(ip_data.free_energy_density); + } + + return cache; + } + + std::vector<double> const& getIntPtEpsPV( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const override + { + cache.clear(); + cache.reserve(_ip_data.size()); + + for (auto const& ip_data : _ip_data) + { + cache.push_back(*ip_data.eps_p_V); + } + + return cache; + } + + std::vector<double> const& getIntPtEpsPDXX( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const override + { + cache.clear(); + cache.reserve(_ip_data.size()); + + for (auto const& ip_data : _ip_data) + { + cache.push_back(*ip_data.eps_p_D_xx); + } + + return cache; + } + + std::vector<double> const& getIntPtSigma( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const override + { + static const int kelvin_vector_size = + MathLib::KelvinVector::KelvinVectorDimensions< + DisplacementDim>::value; + auto const num_intpts = _ip_data.size(); + + cache.clear(); + auto cache_mat = MathLib::createZeroedMatrix<Eigen::Matrix< + double, kelvin_vector_size, Eigen::Dynamic, Eigen::RowMajor>>( + cache, kelvin_vector_size, num_intpts); + + for (unsigned ip = 0; ip < num_intpts; ++ip) + { + auto const& sigma = _ip_data[ip].sigma; + cache_mat.col(ip) = + MathLib::KelvinVector::kelvinVectorToSymmetricTensor(sigma); + } + + return cache; + } + + virtual std::vector<double> const& getIntPtEpsilon( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const override + { + auto const kelvin_vector_size = + MathLib::KelvinVector::KelvinVectorDimensions< + DisplacementDim>::value; + auto const num_intpts = _ip_data.size(); + + cache.clear(); + auto cache_mat = MathLib::createZeroedMatrix<Eigen::Matrix< + double, kelvin_vector_size, Eigen::Dynamic, Eigen::RowMajor>>( + cache, kelvin_vector_size, num_intpts); + + for (unsigned ip = 0; ip < num_intpts; ++ip) + { + auto const& eps = _ip_data[ip].eps; + cache_mat.col(ip) = + MathLib::KelvinVector::kelvinVectorToSymmetricTensor(eps); + } + + return cache; + } + + std::size_t setSigma(double const* values) + { + auto const kelvin_vector_size = + MathLib::KelvinVector::KelvinVectorDimensions< + DisplacementDim>::value; + auto const n_integration_points = _ip_data.size(); + + std::vector<double> ip_sigma_values; + auto sigma_values = + Eigen::Map<Eigen::Matrix<double, kelvin_vector_size, Eigen::Dynamic, + Eigen::ColMajor> const>( + values, kelvin_vector_size, n_integration_points); + + for (unsigned ip = 0; ip < n_integration_points; ++ip) + { + _ip_data[ip].sigma = + MathLib::KelvinVector::symmetricTensorToKelvinVector( + sigma_values.col(ip)); + } + + return n_integration_points; + } + + // TODO (naumov) This method is same as getIntPtSigma but for arguments and + // the ordering of the cache_mat. + // There should be only one. + std::vector<double> getSigma() const override + { + auto const kelvin_vector_size = + MathLib::KelvinVector::KelvinVectorDimensions< + DisplacementDim>::value; + auto const n_integration_points = _ip_data.size(); + + std::vector<double> ip_sigma_values; + auto cache_mat = MathLib::createZeroedMatrix<Eigen::Matrix< + double, Eigen::Dynamic, kelvin_vector_size, Eigen::RowMajor>>( + ip_sigma_values, n_integration_points, kelvin_vector_size); + + for (unsigned ip = 0; ip < n_integration_points; ++ip) + { + auto const& sigma = _ip_data[ip].sigma; + cache_mat.row(ip) = + MathLib::KelvinVector::kelvinVectorToSymmetricTensor(sigma); + } + + return ip_sigma_values; + } + + std::size_t setKappaD(double const* values) + { + unsigned const n_integration_points = + _integration_method.getNumberOfPoints(); + + for (unsigned ip = 0; ip < n_integration_points; ++ip) + { + _ip_data[ip].kappa_d = values[ip]; + } + return n_integration_points; + } + + void setKappaD(double value) + { + for (auto& ip_data : _ip_data) + { + ip_data.kappa_d = value; + } + } + std::vector<double> getKappaD() const override + { + unsigned const n_integration_points = + _integration_method.getNumberOfPoints(); + + std::vector<double> result_values; + result_values.resize(n_integration_points); + + for (unsigned ip = 0; ip < n_integration_points; ++ip) + { + result_values[ip] = _ip_data[ip].kappa_d; + } + + return result_values; + } + + std::vector<double> const& getIntPtDamage( + const double /*t*/, + GlobalVector const& /*current_solution*/, + NumLib::LocalToGlobalIndexMap const& /*dof_table*/, + std::vector<double>& cache) const override + { + cache.clear(); + cache.reserve(_ip_data.size()); + + for (auto const& ip_data : _ip_data) + { + cache.push_back(ip_data.damage); + } + + return cache; + } + + unsigned getNumberOfIntegrationPoints() const override + { + return _integration_method.getNumberOfPoints(); + } + + typename MaterialLib::Solids::MechanicsBase< + DisplacementDim>::MaterialStateVariables const& + getMaterialStateVariablesAt(int const integration_point) const override + { + return *_ip_data[integration_point].material_state_variables; + } + +private: + std::vector<double> const& getIntPtSigma(std::vector<double>& cache, + std::size_t const component) const + { + cache.clear(); + cache.reserve(_ip_data.size()); + + for (auto const& ip_data : _ip_data) + { + if (component < 3) // xx, yy, zz components + cache.push_back(ip_data.sigma[component]); + else // mixed xy, yz, xz components + cache.push_back(ip_data.sigma[component] / std::sqrt(2)); + } + + return cache; + } + + std::vector<double> const& getIntPtEpsilon( + std::vector<double>& cache, std::size_t const component) const + { + cache.clear(); + cache.reserve(_ip_data.size()); + + for (auto const& ip_data : _ip_data) + { + if (component < 3) // xx, yy, zz components + cache.push_back(ip_data.eps[component]); + else // mixed xy, yz, xz components + cache.push_back(ip_data.eps[component] / std::sqrt(2)); + } + + return cache; + } + + IntegrationPointDataNonlocalInterface* + getIPDataPtr(int const ip) override + { + return &_ip_data[ip]; + } + +private: + SmallDeformationNonlocalProcessData<DisplacementDim>& _process_data; + + std::vector< + IntegrationPointData<BMatricesType, ShapeMatricesType, DisplacementDim>, + Eigen::aligned_allocator<IntegrationPointData< + BMatricesType, ShapeMatricesType, DisplacementDim>>> + _ip_data; + + IntegrationMethod const _integration_method; + MeshLib::Element const& _element; + SecondaryData<typename ShapeMatrices::ShapeType> _secondary_data; + bool const _is_axially_symmetric; + + static const int displacement_size = + ShapeFunction::NPOINTS * DisplacementDim; +}; + +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalProcess.cpp b/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalProcess.cpp new file mode 100644 index 0000000000000000000000000000000000000000..c65ae6dacd3954ee7f7e002809061a623692dee4 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalProcess.cpp @@ -0,0 +1,316 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#include "SmallDeformationNonlocalProcess.h" + +#include <nlohmann/json.hpp> +#include <iostream> + +// Reusing local assembler creation code. +#include "ProcessLib/SmallDeformation/CreateLocalAssemblers.h" + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +template <int DisplacementDim> +SmallDeformationNonlocalProcess<DisplacementDim>:: + SmallDeformationNonlocalProcess( + MeshLib::Mesh& mesh, + std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& + jacobian_assembler, + std::vector<std::unique_ptr<ParameterBase>> const& parameters, + unsigned const integration_order, + std::vector<std::vector<std::reference_wrapper<ProcessVariable>>>&& + process_variables, + SmallDeformationNonlocalProcessData<DisplacementDim>&& process_data, + SecondaryVariableCollection&& secondary_variables, + NumLib::NamedFunctionCaller&& named_function_caller) + : Process(mesh, std::move(jacobian_assembler), parameters, + integration_order, std::move(process_variables), + std::move(secondary_variables), std::move(named_function_caller)), + _process_data(std::move(process_data)) +{ + _nodal_forces = MeshLib::getOrCreateMeshProperty<double>( + mesh, "NodalForces", MeshLib::MeshItemType::Node, DisplacementDim); + + _integration_point_writer.emplace_back( + std::make_unique<SigmaIntegrationPointWriter>( + static_cast<int>(mesh.getDimension() == 2 ? 4 : 6) /*n components*/, + integration_order, [this]() { + // Result containing integration point data for each local + // assembler. + std::vector<std::vector<double>> result; + result.resize(_local_assemblers.size()); + + for (std::size_t i = 0; i < _local_assemblers.size(); ++i) + { + auto const& local_asm = *_local_assemblers[i]; + + result[i] = local_asm.getSigma(); + } + + return result; + })); + + _integration_point_writer.emplace_back( + std::make_unique<KappaDIntegrationPointWriter>( + integration_order, [this]() { + // Result containing integration point data for each local + // assembler. + std::vector<std::vector<double>> result; + result.resize(_local_assemblers.size()); + + for (std::size_t i = 0; i < _local_assemblers.size(); ++i) + { + auto const& local_asm = *_local_assemblers[i]; + + result[i] = local_asm.getKappaD(); + } + + return result; + })); +} + +template <int DisplacementDim> +bool SmallDeformationNonlocalProcess<DisplacementDim>::isLinear() const +{ + return false; +} + +template <int DisplacementDim> +void SmallDeformationNonlocalProcess<DisplacementDim>:: + initializeConcreteProcess(NumLib::LocalToGlobalIndexMap const& dof_table, + MeshLib::Mesh const& mesh, + unsigned const integration_order) +{ + // Reusing local assembler creation code. + ProcessLib::SmallDeformation::createLocalAssemblers< + DisplacementDim, SmallDeformationNonlocalLocalAssembler>( + mesh.getElements(), dof_table, _local_assemblers, + mesh.isAxiallySymmetric(), integration_order, _process_data); + + // TODO move the two data members somewhere else. + // for extrapolation of secondary variables + std::vector<MeshLib::MeshSubset> all_mesh_subsets_single_component{ + *_mesh_subset_all_nodes}; + _local_to_global_index_map_single_component = + std::make_unique<NumLib::LocalToGlobalIndexMap>( + std::move(all_mesh_subsets_single_component), + // by location order is needed for output + NumLib::ComponentOrder::BY_LOCATION); + + Process::_secondary_variables.addSecondaryVariable( + "sigma", + makeExtrapolator(MathLib::KelvinVector::KelvinVectorType< + DisplacementDim>::RowsAtCompileTime, + getExtrapolator(), _local_assemblers, + &LocalAssemblerInterface::getIntPtSigma)); + + Process::_secondary_variables.addSecondaryVariable( + "epsilon", + makeExtrapolator(MathLib::KelvinVector::KelvinVectorType< + DisplacementDim>::RowsAtCompileTime, + getExtrapolator(), _local_assemblers, + &LocalAssemblerInterface::getIntPtEpsilon)); + + Process::_secondary_variables.addSecondaryVariable( + "eps_p_V", + makeExtrapolator(1, getExtrapolator(), _local_assemblers, + &LocalAssemblerInterface::getIntPtEpsPV)); + Process::_secondary_variables.addSecondaryVariable( + "eps_p_D_xx", + makeExtrapolator(1, getExtrapolator(), _local_assemblers, + &LocalAssemblerInterface::getIntPtEpsPDXX)); + + Process::_secondary_variables.addSecondaryVariable( + "damage", + makeExtrapolator(1, getExtrapolator(), _local_assemblers, + &LocalAssemblerInterface::getIntPtDamage)); + + GlobalExecutor::executeMemberOnDereferenced( + &LocalAssemblerInterface::nonlocal, _local_assemblers, + _local_assemblers); + + + // Set initial conditions for integration point data. + for (auto const& ip_writer : _integration_point_writer) + { + auto const& name = ip_writer->name(); + // First check the field data, which is used for restart. + if (mesh.getProperties().existsPropertyVector<double>(name)) + { + auto const& mesh_property = + *mesh.getProperties().template getPropertyVector<double>(name); + + // The mesh property must be defined on integration points. + if (mesh_property.getMeshItemType() != + MeshLib::MeshItemType::IntegrationPoint) + { + continue; + } + + auto const ip_meta_data = getIntegrationPointMetaData(mesh, name); + + // Check the number of components. + if (ip_meta_data.n_components != + mesh_property.getNumberOfComponents()) + { + OGS_FATAL( + "Different number of components in meta data (%d) than in " + "the integration point field data for '%s': %d.", + ip_meta_data.n_components, name.c_str(), + mesh_property.getNumberOfComponents()); + } + + // Now we have a properly named vtk's field data array and the + // corresponding meta data. + std::size_t position = 0; + for (auto& local_asm : _local_assemblers) + { + std::size_t const integration_points_read = + local_asm->setIPDataInitialConditions( + name, &mesh_property[position], + ip_meta_data.integration_order); + if (integration_points_read == 0) + { + OGS_FATAL( + "No integration points read in the integration point " + "initial conditions set function."); + } + position += integration_points_read * ip_meta_data.n_components; + } + } + else if (mesh.getProperties().existsPropertyVector<double>(name + + "_ic")) + { // Try to find cell data with '_ic' suffix + auto const& mesh_property = + *mesh.getProperties().template getPropertyVector<double>(name + + "_ic"); + if (mesh_property.getMeshItemType() != MeshLib::MeshItemType::Cell) + { + continue; + } + + // Now we have a vtk's cell data array containing the initial + // conditions for the corresponding integration point writer. + + // For each assembler use the single cell value for all + // integration points. + for (std::size_t i = 0; i < _local_assemblers.size(); ++i) + { + auto& local_asm = _local_assemblers[i]; + + std::vector<double> value( + &mesh_property[i], + &mesh_property[i] + mesh_property.getNumberOfComponents()); + // TODO (naumov) Check sizes / read size / etc. + // OR reconstruct dimensions from size / component = + // ip_points + local_asm->setIPDataInitialConditionsFromCellData(name, value); + } + } + } +} + +template <int DisplacementDim> +void SmallDeformationNonlocalProcess<DisplacementDim>::assembleConcreteProcess( + const double t, GlobalVector const& x, GlobalMatrix& M, GlobalMatrix& K, + GlobalVector& b) +{ + DBUG("Assemble SmallDeformationNonlocalProcess."); + + std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>> + dof_table = {std::ref(*_local_to_global_index_map)}; + // Call global assembler for each local assembly item. + GlobalExecutor::executeMemberDereferenced( + _global_assembler, &VectorMatrixAssembler::assemble, _local_assemblers, + dof_table, t, x, M, K, b, _coupled_solutions); +} + +template <int DisplacementDim> +void SmallDeformationNonlocalProcess< + DisplacementDim>::preAssembleConcreteProcess(const double t, + GlobalVector const& x) +{ + DBUG("preAssemble SmallDeformationNonlocalProcess."); + + // Call global assembler for each local assembly item. + GlobalExecutor::executeMemberDereferenced( + _global_assembler, &VectorMatrixAssembler::preAssemble, + _local_assemblers, *_local_to_global_index_map, t, x); +} + +template <int DisplacementDim> +void SmallDeformationNonlocalProcess<DisplacementDim>:: + assembleWithJacobianConcreteProcess(const double t, GlobalVector const& x, + GlobalVector const& xdot, + const double dxdot_dx, + const double dx_dx, GlobalMatrix& M, + GlobalMatrix& K, GlobalVector& b, + GlobalMatrix& Jac) +{ + DBUG("AssembleWithJacobian SmallDeformationNonlocalProcess."); + + std::vector<std::reference_wrapper<NumLib::LocalToGlobalIndexMap>> + dof_table = {std::ref(*_local_to_global_index_map)}; + // Call global assembler for each local assembly item. + GlobalExecutor::executeMemberDereferenced( + _global_assembler, &VectorMatrixAssembler::assembleWithJacobian, + _local_assemblers, dof_table, t, x, xdot, dxdot_dx, dx_dx, M, K, b, Jac, + _coupled_solutions); + + b.copyValues(*_nodal_forces); + std::transform(_nodal_forces->begin(), _nodal_forces->end(), + _nodal_forces->begin(), [](double val) { return -val; }); +} + +template <int DisplacementDim> +void SmallDeformationNonlocalProcess< + DisplacementDim>::preTimestepConcreteProcess(GlobalVector const& x, + double const t, + double const dt, + int const /*process_id*/) +{ + DBUG("PreTimestep SmallDeformationNonlocalProcess."); + + _process_data.dt = dt; + _process_data.t = t; + + GlobalExecutor::executeMemberOnDereferenced( + &LocalAssemblerInterface::preTimestep, _local_assemblers, + *_local_to_global_index_map, x, t, dt); +} + +template <int DisplacementDim> +NumLib::IterationResult +SmallDeformationNonlocalProcess<DisplacementDim>::postIterationConcreteProcess( + GlobalVector const& x) +{ + _process_data.crack_volume_old = _process_data.crack_volume; + _process_data.crack_volume = 0.0; + + DBUG("PostNonLinearSolver crack volume computation."); + + GlobalExecutor::executeMemberOnDereferenced( + &LocalAssemblerInterface::computeCrackIntegral, _local_assemblers, + *_local_to_global_index_map, x, _process_data.crack_volume); + + INFO("Integral of crack: %g", _process_data.crack_volume); + + return NumLib::IterationResult::SUCCESS; +} + +template class SmallDeformationNonlocalProcess<2>; +template class SmallDeformationNonlocalProcess<3>; + +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalProcess.h b/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalProcess.h new file mode 100644 index 0000000000000000000000000000000000000000..438f9e9379ec1196a9e2ea92f50c8b825720fb54 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalProcess.h @@ -0,0 +1,94 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +#include <cassert> + +#include "BaseLib/Functional.h" +#include "NumLib/DOF/DOFTableUtil.h" +#include "ProcessLib/Process.h" + +#include "IntegrationPointWriter.h" +#include "SmallDeformationNonlocalFEM.h" +#include "SmallDeformationNonlocalProcessData.h" + +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +template <int DisplacementDim> +class SmallDeformationNonlocalProcess final : public Process +{ +public: + SmallDeformationNonlocalProcess( + MeshLib::Mesh& mesh, + std::unique_ptr<ProcessLib::AbstractJacobianAssembler>&& + jacobian_assembler, + std::vector<std::unique_ptr<ParameterBase>> const& parameters, + unsigned const integration_order, + std::vector<std::vector<std::reference_wrapper<ProcessVariable>>>&& + process_variables, + SmallDeformationNonlocalProcessData<DisplacementDim>&& process_data, + SecondaryVariableCollection&& secondary_variables, + NumLib::NamedFunctionCaller&& named_function_caller); + + //! \name ODESystem interface + //! @{ + + bool isLinear() const override; + //! @} + +private: + void initializeConcreteProcess( + NumLib::LocalToGlobalIndexMap const& dof_table, + MeshLib::Mesh const& mesh, + unsigned const integration_order) override; + + void assembleConcreteProcess(const double t, GlobalVector const& x, + GlobalMatrix& M, GlobalMatrix& K, + GlobalVector& b) override; + + void preAssembleConcreteProcess(const double t, + GlobalVector const& x) override; + + void assembleWithJacobianConcreteProcess( + const double t, GlobalVector const& x, GlobalVector const& xdot, + const double dxdot_dx, const double dx_dx, GlobalMatrix& M, + GlobalMatrix& K, GlobalVector& b, GlobalMatrix& Jac) override; + + void preTimestepConcreteProcess(GlobalVector const& x, double const t, + double const dt, + int const /*process_id*/) override; + + NumLib::IterationResult postIterationConcreteProcess( + GlobalVector const& x) override; + +private: + SmallDeformationNonlocalProcessData<DisplacementDim> _process_data; + + using LocalAssemblerInterface = + SmallDeformationNonlocalLocalAssemblerInterface<DisplacementDim>; + std::vector<std::unique_ptr<LocalAssemblerInterface>> _local_assemblers; + + std::unique_ptr<NumLib::LocalToGlobalIndexMap> + _local_to_global_index_map_single_component; + + MeshLib::PropertyVector<double>* _nodal_forces = nullptr; +}; + +extern template class ProcessLib::SmallDeformationNonlocal:: + SmallDeformationNonlocalProcess<2>; +extern template class ProcessLib::SmallDeformationNonlocal:: + SmallDeformationNonlocalProcess<3>; + +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalProcessData.h b/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalProcessData.h new file mode 100644 index 0000000000000000000000000000000000000000..716eaaea2338289c8507caf9b5803bc631b32774 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/SmallDeformationNonlocalProcessData.h @@ -0,0 +1,92 @@ +/** + * \file + * + * \copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +#include <memory> +#include <utility> + +#include <Eigen/Eigen> + +namespace MaterialLib +{ +namespace Solids +{ +template <int DisplacementDim> +struct MechanicsBase; +} +} // namespace MaterialLib +namespace ProcessLib +{ +namespace SmallDeformationNonlocal +{ +template <int DisplacementDim> +struct SmallDeformationNonlocalProcessData +{ + SmallDeformationNonlocalProcessData( + MeshLib::PropertyVector<int> const* const material_ids_, + std::map<int, + std::unique_ptr< + MaterialLib::Solids::MechanicsBase<DisplacementDim>>>&& + solid_materials_, + Parameter<double> const& solid_density_, + Eigen::Matrix<double, DisplacementDim, 1> + specific_body_force_, + double const reference_temperature_, + double const internal_length_) + : material_ids(material_ids_), + solid_materials{std::move(solid_materials_)}, + solid_density(solid_density_), + specific_body_force(std::move(specific_body_force_)), + reference_temperature(reference_temperature_), + internal_length_squared(internal_length_ * internal_length_) + { + } + + SmallDeformationNonlocalProcessData( + SmallDeformationNonlocalProcessData&& other) = default; + + //! Copies are forbidden. + SmallDeformationNonlocalProcessData( + SmallDeformationNonlocalProcessData const&) = delete; + + //! Assignments are not needed. + void operator=(SmallDeformationNonlocalProcessData const&) = delete; + + //! Assignments are not needed. + void operator=(SmallDeformationNonlocalProcessData&&) = delete; + + MeshLib::PropertyVector<int> const* const material_ids; + + std::map< + int, + std::unique_ptr<MaterialLib::Solids::MechanicsBase<DisplacementDim>>> + solid_materials; + /// Solid's density. A scalar quantity, Parameter<double>. + Parameter<double> const& solid_density; + /// Specific body forces applied to the solid. + /// It is usually used to apply gravitational forces. + /// A vector of displacement dimension's length. + Eigen::Matrix<double, DisplacementDim, 1> const specific_body_force; + + double crack_volume_old = 0.0; + double crack_volume = 0.0; + + double dt = 0; + double t = 0; + double const reference_temperature; + double const internal_length_squared; + + EIGEN_MAKE_ALIGNED_OPERATOR_NEW; +}; + +} // namespace SmallDeformationNonlocal +} // namespace ProcessLib diff --git a/ProcessLib/SmallDeformationNonlocal/Tests.cmake b/ProcessLib/SmallDeformationNonlocal/Tests.cmake new file mode 100644 index 0000000000000000000000000000000000000000..49943e4db764e76e7884ef5d898b73f3f8e25262 --- /dev/null +++ b/ProcessLib/SmallDeformationNonlocal/Tests.cmake @@ -0,0 +1,21 @@ +if (NOT OGS_USE_MPI) + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/coarse/bar.prj") + # same as bar/coarse but with tangent type being Elastic. + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar.prj" LARGE) + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/medium/bar.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/fine/bar.prj" LARGE) + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/veryfine/bar.prj" LARGE) + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/p1/bar.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/p2/bar.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/p3/bar.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/t1/bar.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/bar/t2/bar.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/beam/coarse/beam.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/beam/medium/beam.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/beam/fine/beam.prj" LARGE) + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam.prj") + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam.prj" LARGE) + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam.prj" LARGE) + OgsTest(PROJECTFILE "Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam.prj" LARGE) +endif() # OGS_USE_MPI diff --git a/Tests/Data/Mechanics/Ehlers/MFront/cube_1e0_dp.prj b/Tests/Data/Mechanics/Ehlers/MFront/cube_1e0_dp.prj index 23fdaf5bbe84dc3b50fc06d01dde012e854fff7b..936c3b4fbad43f6ce2affa1bf0feccb39afe8c05 100644 --- a/Tests/Data/Mechanics/Ehlers/MFront/cube_1e0_dp.prj +++ b/Tests/Data/Mechanics/Ehlers/MFront/cube_1e0_dp.prj @@ -37,6 +37,7 @@ <mp>mp</mp> <betap>betap</betap> <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> <nonlinear_solver> <maximum_iterations>100</maximum_iterations> <error_tolerance>1e-14</error_tolerance> diff --git a/Tests/Data/Mechanics/Ehlers/axisymmetric_sphere_pl.prj b/Tests/Data/Mechanics/Ehlers/axisymmetric_sphere_pl.prj index 88f4691a7ba486a35e0eec5e4cc0b17c750bd0bd..a939aeeba273274070a795044147eb3c132610a6 100644 --- a/Tests/Data/Mechanics/Ehlers/axisymmetric_sphere_pl.prj +++ b/Tests/Data/Mechanics/Ehlers/axisymmetric_sphere_pl.prj @@ -29,6 +29,7 @@ <mp>mp</mp> <betap>betap</betap> <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> <nonlinear_solver> <maximum_iterations>1000</maximum_iterations> <error_tolerance>1e-8</error_tolerance> diff --git a/Tests/Data/Mechanics/Ehlers/cube_1e0.prj b/Tests/Data/Mechanics/Ehlers/cube_1e0.prj index 03a631afe45f9a7008e5983522071807cd136c8d..bed2dc8872f21a9da1fdf75874ebe68b4bb096c0 100644 --- a/Tests/Data/Mechanics/Ehlers/cube_1e0.prj +++ b/Tests/Data/Mechanics/Ehlers/cube_1e0.prj @@ -25,6 +25,7 @@ <mp>mp</mp> <betap>betap</betap> <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> <nonlinear_solver> <maximum_iterations>100</maximum_iterations> <error_tolerance>1e-14</error_tolerance> diff --git a/Tests/Data/Mechanics/Ehlers/cube_1e0_dp.prj b/Tests/Data/Mechanics/Ehlers/cube_1e0_dp.prj index 75507a73f714600151c523aad71ade3e6d572e28..7e3f2526313d482ff5c16bce0923a33969f4b1d8 100644 --- a/Tests/Data/Mechanics/Ehlers/cube_1e0_dp.prj +++ b/Tests/Data/Mechanics/Ehlers/cube_1e0_dp.prj @@ -25,6 +25,7 @@ <mp>mp</mp> <betap>betap</betap> <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> <nonlinear_solver> <maximum_iterations>100</maximum_iterations> <error_tolerance>1e-14</error_tolerance> diff --git a/Tests/Data/Mechanics/Ehlers/cube_1e1.prj b/Tests/Data/Mechanics/Ehlers/cube_1e1.prj index c41313d7012937091055862e1d82d079b7233130..74070b4e1e2449fd1b6b80f25f15ce41a8163ad7 100644 --- a/Tests/Data/Mechanics/Ehlers/cube_1e1.prj +++ b/Tests/Data/Mechanics/Ehlers/cube_1e1.prj @@ -25,6 +25,7 @@ <mp>mp</mp> <betap>betap</betap> <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> <nonlinear_solver> <maximum_iterations>100</maximum_iterations> <error_tolerance>1e-14</error_tolerance> diff --git a/Tests/Data/Mechanics/Ehlers/cube_1e3.prj b/Tests/Data/Mechanics/Ehlers/cube_1e3.prj index c2a3b2009336583b4590d0d62e0c8a44fc2a501d..9f02f09a852b6ef26760d081376c127d8957edce 100644 --- a/Tests/Data/Mechanics/Ehlers/cube_1e3.prj +++ b/Tests/Data/Mechanics/Ehlers/cube_1e3.prj @@ -25,6 +25,7 @@ <mp>mp</mp> <betap>betap</betap> <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> <nonlinear_solver> <maximum_iterations>100</maximum_iterations> <error_tolerance>1e-14</error_tolerance> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith.gml new file mode 100644 index 0000000000000000000000000000000000000000..f1b6527f36f57b0bc063378e0fdb5beceb77ad17 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:c1f420736ccf917865c5fea1d1e7067784774bc8b7ec78bb336692ac633c7042 +size 915 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith.prj new file mode 100644 index 0000000000000000000000000000000000000000..a07600f1f03179224a67cfc99c7993d45df3f5b1 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith.prj @@ -0,0 +1,279 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>griffith_quad.vtu</mesh> + <geometry>griffith.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>4</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.01e-6</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-6</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1</t_end> + <timesteps> + <pair> + <repeat>1000000</repeat> + <delta_t>0.05</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_crack</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>34.78e9</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>38.10e9</value> + </parameter> + <parameter> + <name>kappa</name> + <type>MeshElement</type> + <field_name>strength</field_name> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.0</coords> + <values>0. 0.0001</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>griffith</geometrical_set> + <geometry>bottom</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>griffith</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>griffith</geometrical_set> + <geometry>top</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>10000</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith.vtu new file mode 100644 index 0000000000000000000000000000000000000000..ebd0e3b950f8e1da79d40e704f163447f780f511 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:c8ff3ef8c4e80576ff2eadde6f2575274ec13f734b6af67cfb61400fdf94bb91 +size 143584 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith_quad.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith_quad.vtu new file mode 100644 index 0000000000000000000000000000000000000000..bf19ee756a5ff6b32f9a68ee1375c55a4f64cc7c --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/CrackedSolid/griffith_quad.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:9e44274183dca37e077a11b409fa7b6e0f3b6a752bbe393a719cddac2ceb3d59 +size 1870133 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..30dd86cba5d39c89a8ceeb17c8c386bdfa40c1cc --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_coarse.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>10000</maximum_iterations> + <error_tolerance>1e-15</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-15</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>10000</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-8</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>1.5e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>sigma</field> + <absolute_tolerance>3e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/bar_coarse.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/bar_coarse.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b46567454531106eed99490cbb42d3ac82721a6e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/bar_coarse.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:3bf16b35f6549f00553e4a6b2d32acb33d09e54aa7c0d19e4d9914ac796d7d6d +size 9234 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..164c3d1f5dc1714c521892808a89d3d394bc2870 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:49561dffc22361f0f471288c1cfd1dfd4ff632bbc40adab1d14736f13446713d +size 29076 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..9ead097eccca2d9c61d27113b49e285326c3143d --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:b88cb567afb262283e7ce3d90960a38e1139d4d6a85bd4eb19486cc27589910b +size 29317 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..29cc452fbc647ecaa07fab27cddaa28b3153daa5 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:5f8abab1f64d7aa3cda153632f8c0034c2678c08fd196d93954be9e00e4dfe0f +size 29762 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..3f05ea34674d69e809bef87d3374c6408de7eaa0 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_coarse.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Elastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>10000</maximum_iterations> + <error_tolerance>1e-15</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-15</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>10000</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>3e-10</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-3</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-10</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-3</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-10</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-3</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar_coarse.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar_coarse.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b46567454531106eed99490cbb42d3ac82721a6e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/bar_coarse.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:3bf16b35f6549f00553e4a6b2d32acb33d09e54aa7c0d19e4d9914ac796d7d6d +size 9234 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..164c3d1f5dc1714c521892808a89d3d394bc2870 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:49561dffc22361f0f471288c1cfd1dfd4ff632bbc40adab1d14736f13446713d +size 29076 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..9ead097eccca2d9c61d27113b49e285326c3143d --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:b88cb567afb262283e7ce3d90960a38e1139d4d6a85bd4eb19486cc27589910b +size 29317 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..29cc452fbc647ecaa07fab27cddaa28b3153daa5 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/coarse_elastic_tangent/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:5f8abab1f64d7aa3cda153632f8c0034c2678c08fd196d93954be9e00e4dfe0f +size 29762 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..6dd6a846f3e438a59f01d59e46b997a668327f2a --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_fine.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_fine_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>3e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>sigma</field> + <absolute_tolerance>6e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_fine_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/bar_fine.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/bar_fine.vtu new file mode 100644 index 0000000000000000000000000000000000000000..96244d792c3239bc6e238e39514a7ebf5238aadc --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/bar_fine.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:49fd72d5b7f0246ca4cca78c8c676f71a4097b7f45ff830b7d7f61a737edacf1 +size 117271 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/out_bar_fine_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/out_bar_fine_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..3cf828d72a2229df422b09b28be0b231c79eb746 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/out_bar_fine_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:17b1469bf46177618075da3c40563b381e89e637a2ca6e2cec43bcdf6ed6e844 +size 190049 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/out_bar_fine_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/out_bar_fine_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..da19534ebc8788283babb132a41ff9228345f8a5 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/out_bar_fine_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:4cf3468a9efadc87bc33db24da90749b2d046a1ba6adccb002f75f8ac1d24818 +size 191585 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/out_bar_fine_ED_pcs_0_ts_90_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/out_bar_fine_ED_pcs_0_ts_90_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..5963c72f31233355f72e73b246acfc4d0e1d30cf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/fine/out_bar_fine_ED_pcs_0_ts_90_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:61442550a34b7b06635cc054cd60f6e2ff5fd8f28d5deb6e74cda375e991340c +size 192757 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..9fba797dab3d9b15c5beff88f0c613a12a33d8d1 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_medium.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_medium_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>1e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>sigma</field> + <absolute_tolerance>3e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_medium_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/bar_medium.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/bar_medium.vtu new file mode 100644 index 0000000000000000000000000000000000000000..2a4f374de324862fb818e7a4d0e29a8198184e71 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/bar_medium.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:cbd4e82a8e3714204a7ce8a118ef7f7cde623712c72f7f9656ca59260fafa14d +size 31380 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_med_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_med_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..5675bc23ed42b20ecacbefa4c72e859c0e4ef866 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_med_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:fac0a76c42b2d28dd7a0d21412713dcfa6e44065c82966d097dacadfe51221a7 +size 51609 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_med_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_med_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..00c953b4c31dda6e61e6090c023847228e43c2c7 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_med_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:e8a360706a7a1efb2e8f713792ecdf913330ff289bc64fd0b3a5c668be1696b5 +size 52349 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_med_ED_pcs_0_ts_90_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_med_ED_pcs_0_ts_90_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..53b0f5c8505dc2a441e991c0e3a9157e50e3f69e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_med_ED_pcs_0_ts_90_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:4bf70cdeec497403ccde1c06bb68595c2ed50fdde13fd0b14e894ee220831190 +size 52905 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_medium_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_medium_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..5675bc23ed42b20ecacbefa4c72e859c0e4ef866 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_medium_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:fac0a76c42b2d28dd7a0d21412713dcfa6e44065c82966d097dacadfe51221a7 +size 51609 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_medium_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_medium_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..00c953b4c31dda6e61e6090c023847228e43c2c7 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_medium_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:e8a360706a7a1efb2e8f713792ecdf913330ff289bc64fd0b3a5c668be1696b5 +size 52349 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_medium_ED_pcs_0_ts_90_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_medium_ED_pcs_0_ts_90_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..53b0f5c8505dc2a441e991c0e3a9157e50e3f69e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/medium/out_bar_medium_ED_pcs_0_ts_90_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:4bf70cdeec497403ccde1c06bb68595c2ed50fdde13fd0b14e894ee220831190 +size 52905 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..45d3effb97a14b67a203885b04e64b262be662d3 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_coarse.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-12</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>6e-8</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/bar_coarse.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/bar_coarse.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b46567454531106eed99490cbb42d3ac82721a6e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/bar_coarse.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:3bf16b35f6549f00553e4a6b2d32acb33d09e54aa7c0d19e4d9914ac796d7d6d +size 9234 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..dfd19e2b548b25d6d3483a24129ce1c39445c60d --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:d62868528f621ebed51dba06fc95a64d5e3f924b7b27ef3a31d3531b1cb5ab07 +size 16965 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..c0b97a766a7d13b94305fb98130b5a0f5d01fa19 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:d116e7e2947952ed20db6b8fffda99198fbcc5ad252b080ba16490b7281701aa +size 17121 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..ce6aa7dceb0cfd1bc7573a09a2691e7364171deb --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p1/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:6725517e6864b60662308826f518a154936c42e0b27d0cb10b34f81360a8a206 +size 17329 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..37c4268c23d2cc5616be7e0d970d083be81a3d98 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_coarse.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-10</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>7e-8</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/bar_coarse.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/bar_coarse.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b46567454531106eed99490cbb42d3ac82721a6e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/bar_coarse.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:3bf16b35f6549f00553e4a6b2d32acb33d09e54aa7c0d19e4d9914ac796d7d6d +size 9234 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..673472097e8cf5733acd256b7d193ee5a7e83962 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:0058c4eaa15d6efc002df30dc660990a1a7fcf8cc744abfba7d7696ed43065d4 +size 17041 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..cb9eb5ca4cf43e9b186951acd8b1b8e235a4cacd --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:1ee56e099ca9870baf22f8983760d29deabde2b5bdabfaa29873e361db3a94f9 +size 17197 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..1d9627e6194243a05a85e24c46d0ab15bd35423e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p2/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:de71d185510a5242aa54db9c6d6acbd4c54e30f0423189338b8793f6934ee9e6 +size 17369 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..570d6d86e9a5b7895e059442d6a7dbcc868a0786 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_coarse.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-6</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>7e-8</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/bar_coarse.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/bar_coarse.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b46567454531106eed99490cbb42d3ac82721a6e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/bar_coarse.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:3bf16b35f6549f00553e4a6b2d32acb33d09e54aa7c0d19e4d9914ac796d7d6d +size 9234 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..501974f01699e8b13d4a13322fc40ba56d4bac44 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/out_bar_coarse_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:2ba5dd81b583e9793c55b55618ca37f53d0c7a68960548035a7b5a805a62da94 +size 17637 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..6ff3fc2b8204cdc50916a5f2ceffc6e86a02d10c --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/out_bar_coarse_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:c2dd0fb61c078802607c555bc6579c799657bf7bcbd5b3dea3356791cc36e96e +size 17829 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..56600f7fb500e1a4c34a69bc10c417b9fe3192d5 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/p3/out_bar_coarse_ED_pcs_0_ts_90_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:db7c43025665c3b071e7f99c1a5f0cb5439b7e8839087f7c5ff2e4e5bc5352f0 +size 17977 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..73f51ffe0b7bf85284a609ee46a1b9a5eca98296 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_coarse.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.001</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_300_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_300_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_300_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-8</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_300_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_600_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_600_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_600_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_600_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_900_t_0.900000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_900_t_0.900000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_900_t_0.900000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_900_t_0.900000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/bar_coarse.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/bar_coarse.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b46567454531106eed99490cbb42d3ac82721a6e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/bar_coarse.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:3bf16b35f6549f00553e4a6b2d32acb33d09e54aa7c0d19e4d9914ac796d7d6d +size 9234 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/out_bar_coarse_ED_pcs_0_ts_300_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/out_bar_coarse_ED_pcs_0_ts_300_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..52e2235c97302785dbe7f25924aa87a6c917d16a --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/out_bar_coarse_ED_pcs_0_ts_300_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:024433673154b59d49537b8aa83a57b3307a00291290ce98e2be2a28293242db +size 17441 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/out_bar_coarse_ED_pcs_0_ts_600_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/out_bar_coarse_ED_pcs_0_ts_600_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..955ed7782bbc6ee2187fc4c4c3776eec04662ccb --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/out_bar_coarse_ED_pcs_0_ts_600_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:0ca5e6c2c78555f1434d1ba80c7266ecdc7c8399a83a5eb9a922812e641cd317 +size 17617 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/out_bar_coarse_ED_pcs_0_ts_900_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/out_bar_coarse_ED_pcs_0_ts_900_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..38a5626a1cb420319f991d27b9c313d80ec928ad --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t1/out_bar_coarse_ED_pcs_0_ts_900_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:1128c622c4c3403473838acd7c656b183ac7b9bbdc1cd0ab30a75cb52598cf7a +size 17817 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..53f19c5a63826d9e09f9c6e0e32f0472c6d87015 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_coarse.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>2000</repeat> + <delta_t>0.0005</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>2000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_600_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_600_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_600_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-8</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_600_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_1200_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_1200_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_1200_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_1200_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_1800_t_0.900000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_1800_t_0.900000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_1800_t_0.900000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_coarse_ED_pcs_0_ts_1800_t_0.900000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/bar_coarse.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/bar_coarse.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b46567454531106eed99490cbb42d3ac82721a6e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/bar_coarse.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:3bf16b35f6549f00553e4a6b2d32acb33d09e54aa7c0d19e4d9914ac796d7d6d +size 9234 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/out_bar_coarse_ED_pcs_0_ts_1200_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/out_bar_coarse_ED_pcs_0_ts_1200_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..8363447b2bebcced6e69e3b9cffd5a8a610e12b4 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/out_bar_coarse_ED_pcs_0_ts_1200_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:74275d631cfe90dd0d08cc43f9a8c42e94f41020d59211e517b93b61c883cfbd +size 17601 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/out_bar_coarse_ED_pcs_0_ts_1800_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/out_bar_coarse_ED_pcs_0_ts_1800_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b2d33135a31d0386bad414b958053d9c940286cf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/out_bar_coarse_ED_pcs_0_ts_1800_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:659101030d550ae8fde42fb5a6fe18a9f3db16dfd967c37fcc58a1d41a159685 +size 17817 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/out_bar_coarse_ED_pcs_0_ts_600_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/out_bar_coarse_ED_pcs_0_ts_600_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..c2d223f038d3d59971904ba9bd2c81225225a70c --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/t2/out_bar_coarse_ED_pcs_0_ts_600_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31f3d5d13c109f54e2d456bba3d099cdc11096047d69da27fc4c8922b3167e6e +size 17421 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/bar.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/bar.gml new file mode 100644 index 0000000000000000000000000000000000000000..d027ec69959617b60f84b7119f04531a73504faf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/bar.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31e873609819bceb1d1ef737387123b37ea8150ee2065da3a963f44065088f9e +size 1030 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/bar.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/bar.prj new file mode 100644 index 0000000000000000000000000000000000000000..dda4ee488bf650f89ab008e1d01a68cc93cba95b --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/bar.prj @@ -0,0 +1,353 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>bar_veryfine.vtu</mesh> + <geometry>bar.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-4</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.25</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-6</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>0.7</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_bar_veryfine_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.0005</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>bar</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>1000</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>1e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_70_t_0.700000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_70_t_0.700000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_70_t_0.700000.vtu</file> + <field>sigma</field> + <absolute_tolerance>1e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_bar_veryfine_ED_pcs_0_ts_70_t_0.700000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/bar_veryfine.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/bar_veryfine.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b6e0352af0a8319d6f4cd3e9d8d561fe7f4220b6 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/bar_veryfine.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:d2a4d1076f239a580a6a0d4f2d5c8f8a304f50d7aa114fd7f2be8865a2a3c2a9 +size 455448 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/out_bar_veryfine_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/out_bar_veryfine_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..a5e35550cd2618b885b03e4aa5cfa6924a8185ef --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/out_bar_veryfine_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:da7d6a30981814b4ee07fe1e36da9a05ab124bee4e153ecedde1bb82784de3e9 +size 757885 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/out_bar_veryfine_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/out_bar_veryfine_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..f86b4aa036dfa28280d538b6c97773a6035c2920 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/out_bar_veryfine_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:490ef1d290327a72638a1f66d4019ba941817e79f859d062ce3202b435534446 +size 762793 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/out_bar_veryfine_ED_pcs_0_ts_70_t_0.700000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/out_bar_veryfine_ED_pcs_0_ts_70_t_0.700000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..d715cf0bdec572409b1574665d01abe471e916e6 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/bar/veryfine/out_bar_veryfine_ED_pcs_0_ts_70_t_0.700000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:f0f07171827f97eb213c85493d27ce22f21592e1acd7e96924b6d5c93a2c9e1e +size 765441 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam.gml new file mode 100644 index 0000000000000000000000000000000000000000..521840a1d5b891350c467d743efec6ce94703620 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:1d1ee1c0b4d88977e489ea42b565ecc74d9bd154f85339b9d5331d5aba1210e5 +size 1194 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam.prj new file mode 100644 index 0000000000000000000000000000000000000000..ed14178bcebca9bb7af80b9ced3cf5fa2297338f --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam.prj @@ -0,0 +1,387 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>beam_3d_hex.vtu</mesh> + <geometry>beam.gml</geometry> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>1000</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0 0</specific_body_force> + <internal_length>0.1</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_beam_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. -0.001</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>3</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>2</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>top</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>sigma</field> + <absolute_tolerance>3e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>4e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam_3d_hex.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam_3d_hex.vtu new file mode 100644 index 0000000000000000000000000000000000000000..2c2cece60286c592d29de61f0005e25311e95b10 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/beam_3d_hex.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:542af6070105f3a765d54eac6d1ae60146142cd49541ae01f55d21683ad61e32 +size 122091 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..320e1d9b2cfd69bd13395613e232bf9d5684d22b --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:34baa66976f76bf19b6d389a0597a21a17251fd15680f045d8a7e6ae1c943d5a +size 270873 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..1254c2731081bde56075ec9c5b59a646019cc733 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:8903a760178b8da4f225d1cd86f6814f165be711eb5a14909e5439e0c9fc04bb +size 265221 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..ff848ae1f41c714bf6f13f16fe92b3a7c5c90e5b --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:6df721030bd59f6fa144700ae2b642c52fab5b73604e5f5cf59f53b11aaca03f +size 267465 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..322942b8c665206985793ccc89c4c6ced96d1b06 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_hexa/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:f31cc43382aacd90191675911e7125578c2d5b026349cb3051c6bfa1398cbfe5 +size 269185 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam.gml new file mode 100644 index 0000000000000000000000000000000000000000..521840a1d5b891350c467d743efec6ce94703620 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:1d1ee1c0b4d88977e489ea42b565ecc74d9bd154f85339b9d5331d5aba1210e5 +size 1194 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam.prj new file mode 100644 index 0000000000000000000000000000000000000000..de0c20c6238362ed227659b6400f881ee31c055a --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam.prj @@ -0,0 +1,387 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>beam_uns_3d.vtu</mesh> + <geometry>beam.gml</geometry> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>1000</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0 0</specific_body_force> + <internal_length>0.1</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>0.4</t_end> + <timesteps> + <pair> + <repeat>40</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_beam_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. -0.001</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>3</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>left</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>right</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>2</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>top</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_10_t_0.100000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_10_t_0.100000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_10_t_0.100000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-8</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_10_t_0.100000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_20_t_0.200000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_20_t_0.200000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_20_t_0.200000.vtu</file> + <field>sigma</field> + <absolute_tolerance>7e-8</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_20_t_0.200000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_30_t_0.300000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam_uns_3d.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam_uns_3d.vtu new file mode 100644 index 0000000000000000000000000000000000000000..9e056e085ae9e2e881d13e5c5047af6e40a16256 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/beam_uns_3d.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:0813c5f003f54adda2f0a7ac5ace3ba3ba5e1088c28036b49a00051922433d27 +size 142594 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_10_t_0.100000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_10_t_0.100000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..ba2eb3ee75d41f3b04d7c542680b854640fae2b4 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_10_t_0.100000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:955ffd0e64f3173695d5378bc62a4b2f991f25aafda02be1bff9fd7e4687c984 +size 219600 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_20_t_0.200000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_20_t_0.200000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b3daf1a2b2f07d581b1441c84cd638af2443cdac --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_20_t_0.200000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:0e892d350c5ac673055d81b9b77c22bf1632a14904934672c1629eeddb08eb96 +size 231356 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_30_t_0.300000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_30_t_0.300000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..ee2384d83c24dc957b843739dba30644a7fe1bc9 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_30_t_0.300000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:5b5b6c0c517ce40e7cc8d314f5ace62b360f57277a159c4c0664fda2b879c9bb +size 235124 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..cd82d10f3420a50239f9ca08babe64744fec2b24 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/3D_tetr/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:aa9ef8a34e62e70a96cf7d5eb2a5544f351be0ff9b7acf8af1013a26c67d07eb +size 235792 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/beam.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/beam.gml new file mode 100644 index 0000000000000000000000000000000000000000..0e040f68a719f57944a22a8c9af666abcbf66b68 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/beam.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:f29e191ed839862362e09a1259998a9ca6461fc7b234327868ced99a216c9b68 +size 1168 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/beam.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/beam.prj new file mode 100644 index 0000000000000000000000000000000000000000..01c265ef3df5b3324cc877e96d9df94cf9b04b07 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/beam.prj @@ -0,0 +1,380 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>beam_coarse.vtu</mesh> + <geometry>beam.gml</geometry> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.1</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_beam_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. -0.001</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_1</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_4</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>3e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>sigma</field> + <absolute_tolerance>4e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>sigma</field> + <absolute_tolerance>4e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/beam_coarse.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/beam_coarse.vtu new file mode 100644 index 0000000000000000000000000000000000000000..86241d685bfd430d26be2b3eed63008663848173 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/beam_coarse.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:0bed28d248376a35f76f1f04e0e1fc3551ecb15fdf1601563f6fc6e223ee300f +size 37224 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..9a91dc775eef18c2d5252d45a951e2638d92f6eb --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:fbe57712ceb4465a5782cc3d7ef06eb2cc387712619c073ff4bcaf7bca3b4437 +size 55853 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..32d9da2c685e713f490a9d8e99dc7f9dda3b2a0c --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:647075d965b79ec0909c414fbaef4b9d581366f8df43e1dc1b404207fd21508a +size 54717 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..09023d69cf3671ee15bef68d5acd05442e652991 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:27cf7b0217744d64e3c5ca607da9b7b6977b15578aba4fbe5bc557536efe57af +size 55285 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..87988e8144f53dbc8ffc3f0325e9b64f650c846b --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:1cf431c2403e6e288fa172628772509584d923b057816b574723924e29367226 +size 55693 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam.gml new file mode 100644 index 0000000000000000000000000000000000000000..0e040f68a719f57944a22a8c9af666abcbf66b68 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:f29e191ed839862362e09a1259998a9ca6461fc7b234327868ced99a216c9b68 +size 1168 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam.prj new file mode 100644 index 0000000000000000000000000000000000000000..b38aa1d59dd559533af05a1e7a7e295be72a88e5 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam.prj @@ -0,0 +1,380 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>beam_coarse.vtu</mesh> + <geometry>beam.gml</geometry> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>3</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>1000</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.1</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_beam_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. -0.001</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>2</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_1</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_4</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>sigma</field> + <absolute_tolerance>3e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>sigma</field> + <absolute_tolerance>4e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam_coarse.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam_coarse.vtu new file mode 100644 index 0000000000000000000000000000000000000000..a3be34099f8a9eedf66ba28709d209e0c9a18555 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/beam_coarse.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:27b1f8cee603f0daef20e7f515e491d61cd40b5e400c819c90e48b4294022165 +size 81496 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..a51c96b90e7975d04d3be89abe61b939b8cd53cc --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:c4fa2d0d5961ee451e31cf21a14ea8a867b0a2acbb3bdb9a8daf2dafe4f0cb98 +size 159865 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..71764c1dd43d81ded8c788fefbf1c01b2fcc906a --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:7cbefd009e83f014ea500ebeb21a829c9ad99ae83d05b2f18dc8a67efe11894d +size 156393 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..90ae9685e95c8e0dd6680c875562e09caebd4bef --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:be3e86db3f1138c744a0a6f9beb5e6f96f8847205a14ec5efa09a8381a9f78b2 +size 158597 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..e79d3013f4bea52fd0b26dc55b86574506acecc8 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_quad/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:b7a90a63e323b704bba7863e1347cd360a6579cd384ab408a526447a84656c8f +size 159637 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam.gml new file mode 100644 index 0000000000000000000000000000000000000000..0e040f68a719f57944a22a8c9af666abcbf66b68 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:f29e191ed839862362e09a1259998a9ca6461fc7b234327868ced99a216c9b68 +size 1168 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam.prj new file mode 100644 index 0000000000000000000000000000000000000000..28646c875611f7aee08683e8bf6ee29d2177c715 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam.prj @@ -0,0 +1,380 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>beam_uns.vtu</mesh> + <geometry>beam.gml</geometry> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>1000</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.1</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_beam_coarse_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. -0.001</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_1</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_4</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>sigma</field> + <absolute_tolerance>4e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>sigma</field> + <absolute_tolerance>6e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam_uns.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam_uns.vtu new file mode 100644 index 0000000000000000000000000000000000000000..4328d2c03d37bdb0565f29d8c51070a3bd25e7e0 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/beam_uns.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:68eaf4e149061c8ee428489abe3ddef552ce0a4b55f137ffc9d241137f8d4cfc +size 31379 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..947a0870f3e088fcaf938ce7a2c57b8c30d839f2 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_100_t_1.000000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:d353a44c1e9eaafb2c18d150978c9ff3feb25eaf9dba6edb78830d99dca8c06b +size 65132 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..12de08bc344a67b60fc9f6789e90253e42b58273 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_40_t_0.400000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:31bc241357890afda25ca8b81cb75472c0a995d40a6785760b94c238f651840a +size 64680 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..59f643afc733f25ac4fa03f3cadea37f3538a139 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:69c08337ab9d1c246790bbc8c13c28426a3ceedcd91776a2b1054e9aed100d1c +size 64852 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..3d4a541d201712b7fa951c2c282ccc56fc16d625 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/coarse_tria/out_beam_coarse_ED_pcs_0_ts_80_t_0.800000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:d80d94cb8f656bc256be716e404c9bd4d1c9306239989f4456c5a45f9d8cc5eb +size 65008 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/beam.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/beam.gml new file mode 100644 index 0000000000000000000000000000000000000000..caa174b10beedec2cfb87ecbeb26a73623f2583c --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/beam.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:1f5c7b944c39a12e3d038e2cb8165d1a2f50dc80579f17e0fab49b9c8efde5ad +size 975 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/beam.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/beam.prj new file mode 100644 index 0000000000000000000000000000000000000000..67fb8c2d649d0d577c83a14e8cbd96e09b57f394 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/beam.prj @@ -0,0 +1,380 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>beam_fine.vtu</mesh> + <geometry>beam.gml</geometry> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.1</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_beam_fine_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. -0.001</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_1</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_4</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>sigma</field> + <absolute_tolerance>7e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_fine_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/beam_fine.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/beam_fine.vtu new file mode 100644 index 0000000000000000000000000000000000000000..60279d3580deaf52816f651edd40c3288ab1db61 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/beam_fine.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:f657da1fba848ed1e930941328b0e6c8cae8e72f738d481897e91c14fe40a8d5 +size 562028 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_100_t_1.000000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_100_t_1.000000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..36c82d921ced4bbc11ec7544da91b63fedcbe62b --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_100_t_1.000000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:bcc1631239dc1a347629e99bf2a3c2ad441d029cebac06ad146cdc524cce7273 +size 809993 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_40_t_0.400000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_40_t_0.400000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..e83dd9d5032168c79616a31496be507844318632 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_40_t_0.400000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:5bd2952c5d4941ce067a93ffabd1d451f89a95269992e54440125d3e4f6e049a +size 794921 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_50_t_0.500000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_50_t_0.500000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..4d11f3791f5b43718d9c858fed13adae53ca501b --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_50_t_0.500000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:99ce660bf7290c93a0c02d3d73943085bfdb513a6fdb0ac768ed51cc1b80fd1e +size 800501 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..c0cdb4e75eee4bbfc6ed74bb90bdf8b3c95fbe62 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:43ccd7ad9ff101566b902f382b54c118dc46876ecda856963bbab1fb4b59f0ee +size 802149 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_70_t_0.700000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_70_t_0.700000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..5d1af276d861c1d3f1ed43c8959b10aee7a973e2 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_70_t_0.700000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:cd1d7c4c21ec8a77ddacaa50a4f4a82386596df0210ae4744a422271f84ee587 +size 805121 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_80_t_0.800000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_80_t_0.800000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..d702a46aecd37abdbd1726a4992e65c57ec901d0 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_80_t_0.800000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:4d515e11549396ebb4437c246b2bc5cb555dd2ff5f34d34d43fab76bd69d77b3 +size 807917 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_90_t_0.900000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_90_t_0.900000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..f621e17630f9bebe002cb986ef9567eff44ea98e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/fine/out_beam_fine_ED_pcs_0_ts_90_t_0.900000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:a8ec4b7b196cd8136179d9a12ce23f88326f6f5d869e2bdb5fbb725d2901f91d +size 809125 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/beam.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/beam.gml new file mode 100644 index 0000000000000000000000000000000000000000..caa174b10beedec2cfb87ecbeb26a73623f2583c --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/beam.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:1f5c7b944c39a12e3d038e2cb8165d1a2f50dc80579f17e0fab49b9c8efde5ad +size 975 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/beam.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/beam.prj new file mode 100644 index 0000000000000000000000000000000000000000..7219d890240022a4ebea234baf8903faa2279764 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/beam.prj @@ -0,0 +1,380 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>beam_medium.vtu</mesh> + <geometry>beam.gml</geometry> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.1</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-8</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.01</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_beam_medium_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. -0.001</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_0</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_1</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <geometrical_set>beam</geometrical_set> + <geometry>p_4</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>sigma</field> + <absolute_tolerance>4e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_40_t_0.400000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>sigma</field> + <absolute_tolerance>7e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_60_t_0.600000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>sigma</field> + <absolute_tolerance>8e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_80_t_0.800000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>sigma</field> + <absolute_tolerance>9e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_medium_ED_pcs_0_ts_100_t_1.000000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/beam_medium.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/beam_medium.vtu new file mode 100644 index 0000000000000000000000000000000000000000..9d161344564a5df23460cb91bfa560033e17b520 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/beam_medium.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:ad64a2c04bdffb5cb2b2def8fe6444ae0edec542ceb6e7d8d9d73a036c5a73cf +size 142827 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_100_t_1.000000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_100_t_1.000000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..1339bb5d878077ef46525de069838476195b7f00 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_100_t_1.000000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:3a1d9b961f27d12043a8a9647556dc4d7e71a5ab94613750d6f837de78fccecc +size 206705 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_40_t_0.400000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_40_t_0.400000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..8baf9f5ba7d6a1b3ed00f82c3d30f333acf39dc4 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_40_t_0.400000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:4e1d72b05ecbdaf3482de5294e6b419ea391c2cf6b78800f3455148a5d33626d +size 201493 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_60_t_0.600000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_60_t_0.600000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..16556b6fc15434fd0321f4f499aabc88a87de4b2 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_60_t_0.600000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:21bf9170c8e923897e9f571c1f6e1ab76f3b90642bcb57f93ddd78e1f78d1573 +size 203757 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_80_t_0.800000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_80_t_0.800000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..3708cf0e5b8a2e1b757c9fcaa7974118d8714dcf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/beam/medium/out_beam_medium_ED_pcs_0_ts_80_t_0.800000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:4d592cf1b5651dd5b7f05ffc0bb0bd7838a7c1492c54a73915e3a0e1560fc21a +size 205877 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam.prj new file mode 100644 index 0000000000000000000000000000000000000000..169e4437c2ebf604de4f287193b61c237baa89d8 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam.prj @@ -0,0 +1,381 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <meshes> + <mesh>holed_beam_sf.vtu</mesh> + <mesh>holed_beam_left.vtu</mesh> + <mesh>holed_beam_p_1.vtu</mesh> + <mesh>holed_beam_p_5.vtu</mesh> + <mesh>holed_beam_right.vtu</mesh> + </meshes> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>100</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0</specific_body_force> + <internal_length>0.00075</internal_length> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-6</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.0</t_end> + <timesteps> + <pair> + <repeat>400</repeat> + <delta_t>0.0025</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>out_beam_hole_ED</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>8333.3e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>11111.1e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>2.519e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.47</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.001025</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.0001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0</values> + </parameter> + <parameter> + <name>Dirichlet_0</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_load</name> + <type>Constant</type> + <value>1.</value> + </parameter> + <parameter> + <name>Dirichlet_top_y</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_time</curve> + <parameter>Dirichlet_load</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_time</name> + <coords>0. 1.</coords> + <values>0. 0.00004</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>2</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <mesh>holed_beam_left</mesh> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <mesh>holed_beam_left</mesh> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <boundary_condition> + <mesh>holed_beam_p_1</mesh> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_0</parameter> + </boundary_condition> + <!-- force --> + <boundary_condition> + <mesh>holed_beam_right</mesh> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_top_y</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>100</max_iter> + <damping>1</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> + <test_definition> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_100_t_0.250000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_100_t_0.250000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_100_t_0.250000.vtu</file> + <field>sigma</field> + <absolute_tolerance>3e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_100_t_0.250000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_200_t_0.500000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_200_t_0.500000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_200_t_0.500000.vtu</file> + <field>sigma</field> + <absolute_tolerance>5e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_200_t_0.500000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_300_t_0.750000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_300_t_0.750000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_300_t_0.750000.vtu</file> + <field>sigma</field> + <absolute_tolerance>8e-7</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_300_t_0.750000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_400_t_1.000000.vtu</file> + <field>displacement</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>1e-13</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_400_t_1.000000.vtu</file> + <field>damage</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_400_t_1.000000.vtu</file> + <field>sigma</field> + <absolute_tolerance>2e-6</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + <vtkdiff> + <file>out_beam_hole_ED_pcs_0_ts_400_t_1.000000.vtu</file> + <field>epsilon</field> + <absolute_tolerance>2e-11</absolute_tolerance> + <relative_tolerance>0</relative_tolerance> + </vtkdiff> + </test_definition> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_left.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_left.vtu new file mode 100644 index 0000000000000000000000000000000000000000..95b801fe47e4fecd5a7902a3a66c28058749bf80 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_left.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:1ab1c68fc955d540b0f9395743a9c2a100e720954467e5040245a45a56319676 +size 2201 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_p_1.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_p_1.vtu new file mode 100644 index 0000000000000000000000000000000000000000..d1223bdedb3230e2c1d677ae204f00084d5e18ce --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_p_1.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:510bfc8f434c9f9ffd8145b459acd557860b58b43e91a7f8eaf7762a54e42692 +size 1263 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_p_5.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_p_5.vtu new file mode 100644 index 0000000000000000000000000000000000000000..74b161f9fb4d8062b00615be8445d48dcc3b7f3c --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_p_5.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:f22f53f96fd503013c8d51bff5683d7663a730043edb7cd871a737f5d809458e +size 1283 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_right.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_right.vtu new file mode 100644 index 0000000000000000000000000000000000000000..32802a8a0f43c700b81444000094a00b87af6e12 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_right.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:aaa5056691ee9523a0dfe0a0e6bd13f7008389aa0aba4cc5f428df8bb0671c4b +size 2205 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_sf.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_sf.vtu new file mode 100644 index 0000000000000000000000000000000000000000..05f3c42c6f6f541b601235ea7105a741b2bc138e --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/holed_beam_sf.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:d869ec000344dc97838d07056a5f511661974d3b1ed21d7630d2cbd89d0d2665 +size 444604 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_100_t_0.250000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_100_t_0.250000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..17bcdc2274bb801d0553dd5c83b84715a4b3adda --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_100_t_0.250000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:ed761f1fdb456d4a60db3d670d6af47515fd52d3d0b69b2233fe34190e19a0a4 +size 852544 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_200_t_0.500000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_200_t_0.500000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..acd0dbbd6a6914a42036e17a0f138666baf16668 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_200_t_0.500000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:eb7dcce3d18928dc15b6fae01c7ea8fcda16c2ca757c6a43491b6342c13b2c8b +size 859824 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_300_t_0.750000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_300_t_0.750000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..e65c0a41a9bb8042de5a401f4945a21039002ced --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_300_t_0.750000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:f6c525b70d1eec6d9b53769b9e2b61826f00ebb2192c66921e0a3ec061c18d14 +size 862888 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_400_t_1.000000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_400_t_1.000000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..c33490f50d1e5c3d80f5c7ac1d4f706da0ca3f0c --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/holed_beam/out_beam_hole_ED_pcs_0_ts_400_t_1.000000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:928cc6efa188a4530a61071ca392f365410d6de8144ea5516b240f9903db3740 +size 866692 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_10_t_0.250000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_10_t_0.250000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..aeac9f73e7916ca652d439bae0a036b355d4d33a --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_10_t_0.250000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:5e445af9042dda01b4df29f31cb2b30b399d97ef1291f6362b07c88dbedd1159 +size 570276 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_20_t_0.500000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_20_t_0.500000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..0a968b86044b7e88c143f8469c2de838009db763 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_20_t_0.500000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:16a51ed50bddba6a95489db732b2e4cf152f11a3a01d6df28301faec136fa0d3 +size 584004 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_30_t_0.750000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_30_t_0.750000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..4e54b14fbbf974d3dd39f00fa23484dfb1567dc7 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_30_t_0.750000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:5f5485f438f89388de5a64b5e30307c15cc4ef768770a83da130d8a8de1a768f +size 592060 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_40_t_1.000000.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_40_t_1.000000.vtu new file mode 100644 index 0000000000000000000000000000000000000000..05e09afd87150a0ad0e65e7e66b131945a0998e7 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/sm_out_pcs_0_ts_40_t_1.000000.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:21f875cd835787f6df8896ba27047081fba825678712fcfea550cb048421a232 +size 596380 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/smallbeam_3D.gml b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/smallbeam_3D.gml new file mode 100644 index 0000000000000000000000000000000000000000..d4fda6a8560cba2205b4229ad4c1959e04bf161a --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/smallbeam_3D.gml @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:e7847964dafbd720aad60fbdeab4b4d0f8b79eba1ec4f3167a80a3bf67fb5866 +size 1751 diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/smallbeam_3D.prj b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/smallbeam_3D.prj new file mode 100644 index 0000000000000000000000000000000000000000..e6a88df7bd1e45ef5890b472e684ce8ca4763199 --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/smallbeam_3D.prj @@ -0,0 +1,314 @@ +<?xml version="1.0" encoding="ISO-8859-1"?> +<OpenGeoSysProject> + <mesh>smallbeam_3D_quad.vtu</mesh> + <geometry>smallbeam_3D.gml</geometry> + <search_length_algorithm> + <type>fixed</type> + <value>1e-6</value> + </search_length_algorithm> + <processes> + <process> + <name>SD</name> + <type>SMALL_DEFORMATION_NONLOCAL</type> + <integration_order>2</integration_order> + <constitutive_relation> + <type>Ehlers</type> + <shear_modulus>G</shear_modulus> + <bulk_modulus>K</bulk_modulus> + <kappa>kappa</kappa> + <beta>beta</beta> + <gamma>gamma</gamma> + <hardening_modulus>hard</hardening_modulus> + <alpha>alpha</alpha> + <delta>delta</delta> + <eps>epsilon</eps> + <m>m</m> + <alphap>alphap</alphap> + <deltap>deltap</deltap> + <epsp>epsilonp</epsp> + <mp>mp</mp> + <betap>betap</betap> + <gammap>gammap</gammap> + <tangent_type>Plastic</tangent_type> + <damage_properties> + <alpha_d>alphad</alpha_d> + <beta_d>betad</beta_d> + <h_d>hd</h_d> + </damage_properties> + <nonlinear_solver> + <maximum_iterations>10000</maximum_iterations> + <error_tolerance>1e-10</error_tolerance> + </nonlinear_solver> + </constitutive_relation> + <solid_density>rho_sr</solid_density> + <specific_body_force>0 0 0</specific_body_force> + <internal_length>0.0025</internal_length> + <!--eventually to 2.5mm--> + <process_variables> + <process_variable>displacement</process_variable> + </process_variables> + <secondary_variables> + <secondary_variable type="static" internal_name="damage" output_name="damage"/> + <secondary_variable type="static" internal_name="sigma" output_name="sigma"/> + <secondary_variable type="static" internal_name="epsilon" output_name="epsilon"/> + </secondary_variables> + </process> + </processes> + <time_loop> + <processes> + <process ref="SD"> + <nonlinear_solver>basic_newton</nonlinear_solver> + <convergence_criterion> + <type>DeltaX</type> + <norm_type>NORM2</norm_type> + <abstol>1e-6</abstol> + </convergence_criterion> + <time_discretization> + <type>BackwardEuler</type> + </time_discretization> + <time_stepping> + <type>FixedTimeStepping</type> + <t_initial>0</t_initial> + <t_end>1.</t_end> + <timesteps> + <pair> + <repeat>10000</repeat> + <delta_t>0.025</delta_t> + </pair> + </timesteps> + </time_stepping> + </process> + </processes> + <output> + <type>VTK</type> + <prefix>sm_out</prefix> + <timesteps> + <pair> + <repeat>10000</repeat> + <each_steps>1</each_steps> + </pair> + </timesteps> + <variables> + <variable>displacement</variable> + <variable>damage</variable> + <variable>sigma</variable> + <variable>epsilon</variable> + </variables> + </output> + </time_loop> + <parameters> + <parameter> + <name>G</name> + <type>Constant</type> + <value>41129e6</value> + </parameter> + <parameter> + <name>K</name> + <type>Constant</type> + <value>65385e6</value> + </parameter> + <parameter> + <name>kappa</name> + <type>Constant</type> + <value>11.87e6</value> + </parameter> + <parameter> + <name>beta</name> + <type>Constant</type> + <value>0.51</value> + </parameter> + <parameter> + <name>gamma</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>hard</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alpha</name> + <type>Constant</type> + <value>0.00255</value> + </parameter> + <parameter> + <name>delta</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>epsilon</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>m</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>alphap</name> + <type>Constant</type> + <value>0.00255</value> + </parameter> + <parameter> + <name>deltap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>epsilonp</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>mp</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>betap</name> + <type>Constant</type> + <value>0.51</value> + </parameter> + <parameter> + <name>gammap</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>alphad</name> + <type>Constant</type> + <value>0.00075</value> + </parameter> + <parameter> + <name>betad</name> + <type>Constant</type> + <value>0.001</value> + </parameter> + <parameter> + <name>hd</name> + <type>Constant</type> + <value>0.0</value> + </parameter> + <parameter> + <name>displacement0</name> + <type>Constant</type> + <values>0 0 0</values> + </parameter> + <parameter> + <name>Dirichlet_left_x</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_left_y</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_left_z</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_right</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_front</name> + <type>Constant</type> + <value>0.</value> + </parameter> + <parameter> + <name>Dirichlet_top_spatial</name> + <type>Constant</type> + <value>1</value> + </parameter> + <parameter> + <name>Dirichlet_top</name> + <type>CurveScaled</type> + <curve>Dirichlet_top_temporal</curve> + <parameter>Dirichlet_top_spatial</parameter> + </parameter> + <parameter> + <name>rho_sr</name> + <type>Constant</type> + <value>1</value> + </parameter> + </parameters> + <curves> + <curve> + <name>Dirichlet_top_temporal</name> + <coords>0. 1.</coords> + <values>0. -0.00004</values> + </curve> + </curves> + <process_variables> + <process_variable> + <name>displacement</name> + <components>3</components> + <order>1</order> + <initial_condition>displacement0</initial_condition> + <boundary_conditions> + <!-- fixed boundaries --> + <boundary_condition> + <geometrical_set>smallbeam_3D</geometrical_set> + <geometry>bot_dx</geometry> + <type>Dirichlet</type> + <component>0</component> + <parameter>Dirichlet_left_x</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>smallbeam_3D</geometrical_set> + <geometry>bot_dx</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_left_y</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>smallbeam_3D</geometrical_set> + <geometry>bot_dx</geometry> + <type>Dirichlet</type> + <component>2</component> + <parameter>Dirichlet_left_z</parameter> + </boundary_condition> + <boundary_condition> + <geometrical_set>smallbeam_3D</geometrical_set> + <geometry>bot_sx</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_right</parameter> + </boundary_condition> + <!-- displacement --> + <boundary_condition> + <geometrical_set>smallbeam_3D</geometrical_set> + <geometry>top</geometry> + <type>Dirichlet</type> + <component>1</component> + <parameter>Dirichlet_top</parameter> + </boundary_condition> + </boundary_conditions> + </process_variable> + </process_variables> + <nonlinear_solvers> + <nonlinear_solver> + <name>basic_newton</name> + <type>Newton</type> + <max_iter>10000</max_iter> + <damping>1.0</damping> + <linear_solver>general_linear_solver</linear_solver> + </nonlinear_solver> + </nonlinear_solvers> + <linear_solvers> + <linear_solver> + <name>general_linear_solver</name> + <eigen> + <solver_type>SparseLU</solver_type> + <scaling>1</scaling> + </eigen> + </linear_solver> + </linear_solvers> +</OpenGeoSysProject> diff --git a/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/smallbeam_3D_quad.vtu b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/smallbeam_3D_quad.vtu new file mode 100644 index 0000000000000000000000000000000000000000..d0b5f1f68fb4df925e73dfd49213ee2647c7eadf --- /dev/null +++ b/Tests/Data/Mechanics/EhlersDamageNonLocal/notched_beam/smallbeam_3D_quad.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:be3a148c93f9739dd31a8cb652b550d6e891ee8dedcfac2a03df8dcdfca7956e +size 382812