diff --git a/doc/readthedocs/boundaryconditions.rst b/doc/readthedocs/boundaryconditions.rst index 83c9f20eac..1021bb2ac6 100644 --- a/doc/readthedocs/boundaryconditions.rst +++ b/doc/readthedocs/boundaryconditions.rst @@ -213,9 +213,9 @@ The input looks like this: ------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS E NUMDOF 3 ONOFF 0 0 0 \ - STIFF TIMEFUNCTSTIFF 0 0 0 \ - VISCO TIMEFUNCTVISCO 0 0 0 \ - DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 \ + STIFF TIMEFUNCTSTIFF none none none \ + VISCO TIMEFUNCTVISCO none none none \ + DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none \ DIRECTION xyz|refsurfnormal|cursurfnormal COUPLING none - Commonly the Robin boundary condition couples the nodes at the surface to its original position. @@ -236,9 +236,9 @@ The input looks like this: ------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS E NUMDOF 3 ONOFF 0 0 0 \ - STIFF TIMEFUNCTSTIFF 0 0 0 \ - VISCO TIMEFUNCTVISCO 0 0 0 \ - DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 \ + STIFF TIMEFUNCTSTIFF none none none \ + VISCO TIMEFUNCTVISCO none none none \ + DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none \ DIRECTION xyz|refsurfnormal|cursurfnormal COUPLING // ------------------------------DESIGN SURF ROBIN SPRING DASHPOT COUPLING CONDITIONS diff --git a/src/constraint/4C_constraint_springdashpot.cpp b/src/constraint/4C_constraint_springdashpot.cpp index 11c1157a90..27bdc3b308 100644 --- a/src/constraint/4C_constraint_springdashpot.cpp +++ b/src/constraint/4C_constraint_springdashpot.cpp @@ -43,13 +43,20 @@ namespace Core::FE::CelltypeSequence; - double scale_by_optional_function(double baseline_value, int num_func, double total_time) + double scale_by_optional_function( + double baseline_value, Core::IO::Noneable funct_id, double total_time) { - return num_func ? Global::Problem::instance() - ->function_by_id(num_func) - .evaluate(total_time) * - baseline_value - : baseline_value; + if (funct_id.has_value()) + { + return Global::Problem::instance() + ->function_by_id(funct_id.value()) + .evaluate(total_time) * + baseline_value; + } + else + { + return baseline_value; + } } template @@ -260,12 +267,15 @@ CONSTRAINTS::SpringDashpot::SpringDashpot(std::shared_ptrparameters().get>("STIFF"); - const auto* numfuncstiff = &spring_->parameters().get>("TIMEFUNCTSTIFF"); - const auto* numfuncnonlinstiff = &spring_->parameters().get>("FUNCTNONLINSTIFF"); + const auto* function_id_stiffness = + &spring_->parameters().get>>("TIMEFUNCTSTIFF"); + const auto* function_id_nonlinear_stiffness = + &spring_->parameters().get>>("FUNCTNONLINSTIFF"); - for (unsigned i = 0; i < (*numfuncnonlinstiff).size(); ++i) + for (unsigned i = 0; i < (*function_id_nonlinear_stiffness).size(); ++i) { - if ((*numfuncnonlinstiff)[i] != 0 and ((*springstiff)[i] != 0 or (*numfuncstiff)[i] != 0)) + if ((*function_id_nonlinear_stiffness)[i].has_value() and + ((*springstiff)[i] != 0 or *function_id_stiffness)[i].has_value()) FOUR_C_THROW("Must not apply nonlinear stiffness and linear stiffness"); } @@ -318,13 +328,16 @@ void CONSTRAINTS::SpringDashpot::evaluate_robin(std::shared_ptrparameters().get>("ONOFF"); const auto& springstiff = spring_->parameters().get>("STIFF"); - const auto& numfuncstiff = spring_->parameters().get>("TIMEFUNCTSTIFF"); + const auto& function_id_stiffness = + spring_->parameters().get>>("TIMEFUNCTSTIFF"); const auto& dashpotvisc = spring_->parameters().get>("VISCO"); - const auto& numfuncvisco = spring_->parameters().get>("TIMEFUNCTVISCO"); + const auto& function_id_viscosity = + spring_->parameters().get>>("TIMEFUNCTVISCO"); const auto& constant_offset = spring_->parameters().get>("DISPLOFFSET"); - const auto& numfuncdisploffset = - spring_->parameters().get>("TIMEFUNCTDISPLOFFSET"); - const auto& numfuncnonlinstiff = spring_->parameters().get>("FUNCTNONLINSTIFF"); + const auto& function_id_displacement_offset = + spring_->parameters().get>>("TIMEFUNCTDISPLOFFSET"); + const auto& function_id_nonlinear_stiffness = + spring_->parameters().get>>("FUNCTNONLINSTIFF"); const auto& direction = spring_->parameters().get("DIRECTION"); // time-integration factor for stiffness contribution of dashpot, d(v_{n+1})/d(d_{n+1}) @@ -361,14 +374,14 @@ void CONSTRAINTS::SpringDashpot::evaluate_robin(std::shared_ptr 0) + if (function_id_nonlinear_stiffness[i].has_value()) { // function is nonlinear const auto& nonlinear_spring = Global::Problem::instance()->function_by_id( - numfuncnonlinstiff[i]); + function_id_nonlinear_stiffness[i].value()); spring_dashpot_evaluators[i] = [=, &nonlinear_spring](double delta_displacement, @@ -391,7 +404,7 @@ void CONSTRAINTS::SpringDashpot::evaluate_robin(std::shared_ptrfunction_by_id(numfuncstiff[dof]) - .evaluate(total_time) + function_id_stiffness[dof].has_value() + ? springstiff[dof] * Global::Problem::instance() + ->function_by_id( + function_id_stiffness[dof].value()) + .evaluate(total_time) : springstiff[dof]; const double dof_viscosity = - numfuncvisco[dof] != 0 - ? dashpotvisc[dof] * - Global::Problem::instance() - ->function_by_id(numfuncvisco[dof]) - .evaluate(total_time) + function_id_viscosity[dof].has_value() + ? dashpotvisc[dof] * Global::Problem::instance() + ->function_by_id( + function_id_viscosity[dof].value()) + .evaluate(total_time) : dashpotvisc[dof]; const double dof_disploffset = - numfuncdisploffset[dof] != 0 - ? constant_offset[dof] * - Global::Problem::instance() - ->function_by_id(numfuncdisploffset[dof]) - .evaluate(total_time) + function_id_displacement_offset[dof].has_value() + ? constant_offset[dof] * Global::Problem::instance() + ->function_by_id( + function_id_displacement_offset[dof].value()) + .evaluate(total_time) : constant_offset[dof]; // displacement related forces and derivatives double force_disp = 0.0; double force_disp_deriv = 0.0; - if ((numfuncnonlinstiff)[dof] == 0) - { - force_disp = dof_stiffness * (dof_disp - dof_disploffset); - force_disp_deriv = dof_stiffness; - } - else + if (function_id_nonlinear_stiffness[dof].has_value()) { std::array displ = {(*disp)[0], (*disp)[1], (*disp)[2]}; force_disp = Global::Problem::instance() ->function_by_id( - (numfuncnonlinstiff)[dof] - 1) + function_id_nonlinear_stiffness[dof].value()) .evaluate(displ.data(), total_time, 0); - force_disp_deriv = (Global::Problem::instance() ->function_by_id( - (numfuncnonlinstiff)[dof] - 1) + function_id_nonlinear_stiffness[dof].value()) .evaluate_spatial_derivative(displ.data(), total_time, 0))[dof]; } + else + { + force_disp = dof_stiffness * (dof_disp - dof_disploffset); + force_disp_deriv = dof_stiffness; + } // velocity related forces and derivatives const double force_vel = dof_viscosity * dof_vel; @@ -677,36 +689,39 @@ void CONSTRAINTS::SpringDashpot::evaluate_force(Core::LinAlg::Vector& fi case RobinSpringDashpotType::cursurfnormal: // spring dashpot acts in curnormal direction // safety checks - const auto* numfuncstiff = &spring_->parameters().get>("TIMEFUNCTSTIFF"); - const auto* numfuncvisco = &spring_->parameters().get>("TIMEFUNCTVISCO"); - const auto* numfuncdisploffset = - &spring_->parameters().get>("TIMEFUNCTDISPLOFFSET"); - const auto* numfuncnonlinstiff = - &spring_->parameters().get>("FUNCTNONLINSTIFF"); - for (int dof_numfuncstiff : *numfuncstiff) + const auto* function_id_stiffness = + &spring_->parameters().get>>("TIMEFUNCTSTIFF"); + const auto* function_id_viscosity = + &spring_->parameters().get>>("TIMEFUNCTVISCO"); + const auto* function_id_displacement_offset = + &spring_->parameters().get>>( + "TIMEFUNCTDISPLOFFSET"); + const auto* function_id_nonlinear_stiffness = + &spring_->parameters().get>>("FUNCTNONLINSTIFF"); + for (auto dof_function_id_stiffness : *function_id_stiffness) { - if (dof_numfuncstiff != 0) + if (dof_function_id_stiffness.has_value()) { FOUR_C_THROW( "temporal dependence of stiffness not implemented for current surface " "evaluation"); } } - for (int dof_numfuncvisco : *numfuncvisco) + for (auto dof_function_id_viscosity : *function_id_viscosity) { - if (dof_numfuncvisco != 0) + if (dof_function_id_viscosity.has_value()) FOUR_C_THROW( "temporal dependence of damping not implemented for current surface evaluation"); } - for (int dof_numfuncdisploffset : *numfuncdisploffset) + for (auto dof_function_id_displacement_offset : *function_id_displacement_offset) { - if (dof_numfuncdisploffset != 0) + if (dof_function_id_displacement_offset.has_value()) FOUR_C_THROW( "temporal dependence of offset not implemented for current surface evaluation"); } - for (int dof_numfuncnonlinstiff : *numfuncnonlinstiff) + for (auto dof_function_id_nonlinear_stiffness : *function_id_nonlinear_stiffness) { - if (dof_numfuncnonlinstiff != 0) + if (dof_function_id_nonlinear_stiffness.has_value()) FOUR_C_THROW("Nonlinear spring not implemented for current surface evaluation"); } @@ -800,36 +815,39 @@ void CONSTRAINTS::SpringDashpot::evaluate_force_stiff(Core::LinAlg::SparseMatrix case RobinSpringDashpotType::cursurfnormal: // spring dashpot acts in curnormal direction // safety checks - const auto* numfuncstiff = &spring_->parameters().get>("TIMEFUNCTSTIFF"); - const auto* numfuncvisco = &spring_->parameters().get>("TIMEFUNCTVISCO"); - const auto* numfuncdisploffset = - &spring_->parameters().get>("TIMEFUNCTDISPLOFFSET"); - const auto* numfuncnonlinstiff = - &spring_->parameters().get>("FUNCTNONLINSTIFF"); - for (int dof_numfuncstiff : *numfuncstiff) + const auto* function_id_stiffness = + &spring_->parameters().get>>("TIMEFUNCTSTIFF"); + const auto* function_id_viscosity = + &spring_->parameters().get>>("TIMEFUNCTVISCO"); + const auto* function_id_displacement_offset = + &spring_->parameters().get>>( + "TIMEFUNCTDISPLOFFSET"); + const auto* function_id_nonlinear_stiffness = + &spring_->parameters().get>>("FUNCTNONLINSTIFF"); + for (auto dof_function_id_stiffness : *function_id_stiffness) { - if (dof_numfuncstiff != 0) + if (dof_function_id_stiffness.has_value()) { FOUR_C_THROW( "temporal dependence of stiffness not implemented for current surface " "evaluation"); } } - for (int dof_numfuncvisco : *numfuncvisco) + for (auto dof_function_id_viscosity : *function_id_viscosity) { - if (dof_numfuncvisco != 0) + if (dof_function_id_viscosity.has_value()) FOUR_C_THROW( "temporal dependence of damping not implemented for current surface evaluation"); } - for (int dof_numfuncdisploffset : *numfuncdisploffset) + for (auto dof_function_id_displacement_offset : *function_id_displacement_offset) { - if (dof_numfuncdisploffset != 0) + if (dof_function_id_displacement_offset.has_value()) FOUR_C_THROW( "temporal dependence of offset not implemented for current surface evaluation"); } - for (int dof_numfuncnonlinstiff : *numfuncnonlinstiff) + for (auto dof_function_id_nonlinear_stiffness : *function_id_nonlinear_stiffness) { - if (dof_numfuncnonlinstiff != 0) + if (dof_function_id_nonlinear_stiffness.has_value()) FOUR_C_THROW("Nonlinear spring not implemented for current surface evaluation"); } diff --git a/src/fluid/4C_fluid_impedancecondition.cpp b/src/fluid/4C_fluid_impedancecondition.cpp index d88e97d7ce..535b27f870 100644 --- a/src/fluid/4C_fluid_impedancecondition.cpp +++ b/src/fluid/4C_fluid_impedancecondition.cpp @@ -189,7 +189,7 @@ FLD::Utils::FluidImpedanceBc::FluidImpedanceBc( r1_(impedancecond->parameters().get("R1")), r2_(impedancecond->parameters().get("R2")), c_(impedancecond->parameters().get("C")), - functnum_(impedancecond->parameters().get("FUNCT")) + functnum_(impedancecond->parameters().get>("FUNCT")) { if (myrank_ == 0) { @@ -356,10 +356,17 @@ void FLD::Utils::FluidImpedanceBc::calculate_impedance_tractions_and_update_resi } else if (treetype_ == "pressure_by_funct") { - pressure = Global::Problem::instance() - ->function_by_id(functnum_) - .evaluate(time); - Q_np_fac = 0.0; + if (functnum_.has_value()) + { + pressure = Global::Problem::instance() + ->function_by_id(functnum_.value()) + .evaluate(time); + Q_np_fac = 0.0; + } + else + { + FOUR_C_THROW("Error with surface impendance condition: Need to define a positive FUNCT."); + } } else { diff --git a/src/fluid/4C_fluid_impedancecondition.hpp b/src/fluid/4C_fluid_impedancecondition.hpp index 3966f617d3..943f04fb67 100644 --- a/src/fluid/4C_fluid_impedancecondition.hpp +++ b/src/fluid/4C_fluid_impedancecondition.hpp @@ -192,8 +192,8 @@ namespace FLD //! 'material' parameters required for artery tree const double r1_, r2_, c_; - //! curve number - const int functnum_; + //! function number + const Core::IO::Noneable functnum_; //! traction vector for impedance bc std::shared_ptr> impedancetbc_; diff --git a/src/fluid/4C_fluid_volumetric_surfaceFlow_condition.cpp b/src/fluid/4C_fluid_volumetric_surfaceFlow_condition.cpp index ff5e522a81..28f75ec49a 100644 --- a/src/fluid/4C_fluid_volumetric_surfaceFlow_condition.cpp +++ b/src/fluid/4C_fluid_volumetric_surfaceFlow_condition.cpp @@ -190,19 +190,19 @@ FLD::Utils::FluidVolumetricSurfaceFlowBc::FluidVolumetricSurfaceFlowBc( dta_ = dta; // get the cycle period size - period_ = conditions[surf_numcond]->parameters().get("Period"); + period_ = conditions[surf_numcond]->parameters().get("PERIOD"); // get the polynomial order of the profile - order_ = conditions[surf_numcond]->parameters().get("Order"); + order_ = conditions[surf_numcond]->parameters().get("ORDER"); // get the number of harmonics - n_harmonics_ = conditions[surf_numcond]->parameters().get("Harmonics"); + n_harmonics_ = conditions[surf_numcond]->parameters().get("HARMONICS"); // get the profile type - flowprofile_type_ = ((conditions[surf_numcond])->parameters().get("ConditionType")); + flowprofile_type_ = ((conditions[surf_numcond])->parameters().get("CONDITIONTYPE")); // get the prebiasing flag - prebiasing_flag_ = ((conditions[surf_numcond])->parameters().get("prebiased")); + prebiasing_flag_ = ((conditions[surf_numcond])->parameters().get("PREBIAS")); // ------------------------------------------------------------------- // calculate the center of mass and varage normal of the surface @@ -215,7 +215,7 @@ FLD::Utils::FluidVolumetricSurfaceFlowBc::FluidVolumetricSurfaceFlowBc( // get the normal normal_ = std::make_shared>(*normal); std::string normal_info = (conditions[surf_numcond])->parameters().get("NORMAL"); - if (normal_info == "SelfEvaluateNormal") + if (normal_info == "self_evaluate") { if (!myrank_) { @@ -223,16 +223,14 @@ FLD::Utils::FluidVolumetricSurfaceFlowBc::FluidVolumetricSurfaceFlowBc( } vnormal_ = std::make_shared>(*normal); } - else if (normal_info == "UsePrescribedNormal") + else if (normal_info == "use_prescribed") { if (!myrank_) { std::cout << "Normal is manually setup" << std::endl; } - vnormal_ = std::make_shared>(); - (*vnormal_)[0] = conditions[surf_numcond]->parameters().get("n1"); - (*vnormal_)[1] = conditions[surf_numcond]->parameters().get("n2"); - (*vnormal_)[2] = conditions[surf_numcond]->parameters().get("n3"); + auto vnormal = conditions[surf_numcond]->parameters().get>("NVECTOR"); + vnormal_ = std::make_shared>(vnormal); } else { @@ -242,8 +240,8 @@ FLD::Utils::FluidVolumetricSurfaceFlowBc::FluidVolumetricSurfaceFlowBc( // get the center of mass std::string c_mass_info = - (conditions[surf_numcond])->parameters().get("CenterOfMass"); - if (c_mass_info == "SelfEvaluateCenterOfMass") + (conditions[surf_numcond])->parameters().get("CENTEROFMASS"); + if (c_mass_info == "self_evaluate") { if (!myrank_) { @@ -251,16 +249,14 @@ FLD::Utils::FluidVolumetricSurfaceFlowBc::FluidVolumetricSurfaceFlowBc( } cmass_ = std::make_shared>(*cmass); } - else if (c_mass_info == "UsePrescribedCenterOfMass") + else if (c_mass_info == "use_prescribed") { if (!myrank_) { std::cout << "Center of mass is manually setup" << std::endl; } - normal_ = std::make_shared>(); - (*cmass_)[0] = conditions[surf_numcond]->parameters().get("c1"); - (*cmass_)[1] = conditions[surf_numcond]->parameters().get("c2"); - (*cmass_)[2] = conditions[surf_numcond]->parameters().get("c3"); + auto normal = conditions[surf_numcond]->parameters().get>("CVECTOR"); + normal_ = std::make_shared>(normal); } else { @@ -270,12 +266,12 @@ FLD::Utils::FluidVolumetricSurfaceFlowBc::FluidVolumetricSurfaceFlowBc( // check if the condition surface is a inlet or outlet - std::string flow_dir = (conditions[surf_numcond])->parameters().get("FlowType"); - if (flow_dir == "InFlow") + std::string flow_dir = (conditions[surf_numcond])->parameters().get("FLOWTYPE"); + if (flow_dir == "inflow") { flow_dir_ = -1.0; } - else if (flow_dir == "OutFlow") + else if (flow_dir == "outflow") { flow_dir_ = 1.0; } @@ -286,9 +282,7 @@ FLD::Utils::FluidVolumetricSurfaceFlowBc::FluidVolumetricSurfaceFlowBc( } // check if the flow is with correction - std::string corr_flag = - (conditions[surf_numcond])->parameters().get("CorrectionFlag"); - correct_flow_ = (corr_flag == "WithCorrection"); + correct_flow_ = (conditions[surf_numcond])->parameters().get("CORRECTPROFILE"); // ------------------------------------------------------------------- // create the flow rates vector @@ -297,7 +291,7 @@ FLD::Utils::FluidVolumetricSurfaceFlowBc::FluidVolumetricSurfaceFlowBc( flowrates_ = std::make_shared>(num_steps, 0.0); - if (prebiasing_flag_ == "PREBIASED" || prebiasing_flag_ == "FORCED") + if (prebiasing_flag_ == "prebiased" || prebiasing_flag_ == "forced") { for (unsigned int i = 0; i < flowrates_->size(); i++) { @@ -511,7 +505,7 @@ void FLD::Utils::FluidVolumetricSurfaceFlowBc::eval_local_normalized_radii( // ------------------------------------------------------------------- // loop over each node and compare its distance to the - // [CenterOfMass BorderNodes) + // [CENTEROFMASS BorderNodes) // ------------------------------------------------------------------- // get the dimension of the node @@ -962,8 +956,8 @@ double FLD::Utils::FluidVolumetricSurfaceFlowBc::evaluate_flowrate( Core::Conditions::Condition* condition = conditions[condnum_s_]; // get curve and curve_factor - const int functnum = condition->parameters().get("Funct"); - const double val = condition->parameters().get("Val"); + const int functnum = condition->parameters().get("FUNCT"); + const double val = condition->parameters().get("VAL"); // if ( val < 1e-14 ) // FOUR_C_THROW("Val must be positive!"); @@ -971,14 +965,10 @@ double FLD::Utils::FluidVolumetricSurfaceFlowBc::evaluate_flowrate( // evaluate the current flowrate value double functfac = 0.0; double flowrate = 0.0; - - if (functnum > 0) - { - functfac = - Global::Problem::instance()->function_by_id(functnum).evaluate( - time); - flowrate = val * functfac; - } + functfac = + Global::Problem::instance()->function_by_id(functnum).evaluate( + time); + flowrate = val * functfac; return flowrate; } @@ -1047,7 +1037,7 @@ void FLD::Utils::FluidVolumetricSurfaceFlowBc::velocities(Core::FE::Discretizati (*velocities)[i] /= area * flow_dir_; } - if (flowType == "WOMERSLEY") + if (flowType == "womersley") { if (n_harmonics < 1) { @@ -1100,7 +1090,7 @@ void FLD::Utils::FluidVolumetricSurfaceFlowBc::velocities(Core::FE::Discretizati //------------------------------------------------------------ // check for the polynomial type - if (flowType == "POLYNOMIAL") + if (flowType == "polynomial") { if (order != 0) { @@ -1113,7 +1103,7 @@ void FLD::Utils::FluidVolumetricSurfaceFlowBc::velocities(Core::FE::Discretizati } } // else check for Womersley type - else if (flowType == "WOMERSLEY") + else if (flowType == "womersley") { double R = (border_radii)[cond_noderowmap.LID(gid)]; @@ -1236,7 +1226,7 @@ void FLD::Utils::FluidVolumetricSurfaceFlowBc::correct_flow_rate( // the velocity position params->set("Velocity Position", 0); // the flow type - params->set("flowrate type", "POLYNOMIAL"); + params->set("flowrate type", "polynomial"); // time params->set("time", time_in_a_period); // period of a cycle @@ -1862,7 +1852,7 @@ void FLD::Utils::TotalTractionCorrector::evaluate_velocities( { double flowrate = 0.0; - if (mapiter->second->prebiasing_flag() == "FORCED") + if (mapiter->second->prebiasing_flag() == "forced") { flowrate = mapiter->second->evaluate_flowrate("TotalTractionCorrectionCond", time); } diff --git a/src/inpar/4C_inpar_bio.cpp b/src/inpar/4C_inpar_bio.cpp index 220b0d965b..3cc69d0ac5 100644 --- a/src/inpar/4C_inpar_bio.cpp +++ b/src/inpar/4C_inpar_bio.cpp @@ -455,7 +455,7 @@ void Inpar::ReducedLung::set_valid_conditions( impedancebc.add_component(parameter("R2")); impedancebc.add_component(parameter("C")); impedancebc.add_component(parameter("TIMEPERIOD")); - impedancebc.add_component(parameter("FUNCT")); + impedancebc.add_component(parameter>("FUNCT")); condlist.push_back(impedancebc); } diff --git a/src/inpar/4C_inpar_fluid.cpp b/src/inpar/4C_inpar_fluid.cpp index e45068d801..71fccd360b 100644 --- a/src/inpar/4C_inpar_fluid.cpp +++ b/src/inpar/4C_inpar_fluid.cpp @@ -1516,43 +1516,47 @@ void Inpar::FLUID::set_valid_conditions( volumetric_surface_flow_cond.add_component(parameter("ConditionID")); volumetric_surface_flow_cond.add_component( - selection("ConditionType", {"POLYNOMIAL", "WOMERSLEY"}, - {.description = "condition type", .default_value = "POLYNOMIAL"})); + selection("CONDITIONTYPE", {"polynomial", "womersley"}, + {.description = "condition type", .default_value = "polynomial"})); volumetric_surface_flow_cond.add_component( - selection("prebiased", {"NOTPREBIASED", "PREBIASED", "FORCED"}, - {.description = "prebiased", .default_value = "NOTPREBIASED"})); + selection("PREBIAS", {"not_prebiased", "prebiased", "forced"}, + {.description = "prebias type", .default_value = "not_prebiased"})); volumetric_surface_flow_cond.add_component(selection( - "FlowType", {"InFlow", "OutFlow"}, {.description = "flow type", .default_value = "InFlow"})); - volumetric_surface_flow_cond.add_component( - selection("CorrectionFlag", {"WithOutCorrection", "WithCorrection"}, - {.description = "correction flag", .default_value = "WithOutCorrection"})); - - volumetric_surface_flow_cond.add_component(parameter("Period")); - volumetric_surface_flow_cond.add_component(parameter("Order")); - volumetric_surface_flow_cond.add_component(parameter("Harmonics")); - volumetric_surface_flow_cond.add_component(parameter("Val")); - volumetric_surface_flow_cond.add_component(parameter("Funct")); - - volumetric_surface_flow_cond.add_component( - selection("NORMAL", {"SelfEvaluateNormal", "UsePrescribedNormal"}, - {.description = "normal", .default_value = "SelfEvaluateNormal"})); - volumetric_surface_flow_cond.add_component(parameter("n1")); - volumetric_surface_flow_cond.add_component(parameter("n2")); - volumetric_surface_flow_cond.add_component(parameter("n3")); - - volumetric_surface_flow_cond.add_component(selection("CenterOfMass", - {"SelfEvaluateCenterOfMass", "UsePrescribedCenterOfMass"}, - {.description = "center of mass", .default_value = "SelfEvaluateCenterOfMass"})); - volumetric_surface_flow_cond.add_component(parameter("c1")); - volumetric_surface_flow_cond.add_component(parameter("c2")); - volumetric_surface_flow_cond.add_component(parameter("c3")); + "FLOWTYPE", {"inflow", "outflow"}, {.description = "flow type", .default_value = "inflow"})); + volumetric_surface_flow_cond.add_component(parameter( + "CORRECTPROFILE", {.description = "correction flag", .default_value = false})); + + volumetric_surface_flow_cond.add_component(parameter("PERIOD")); + volumetric_surface_flow_cond.add_component(parameter("ORDER")); + volumetric_surface_flow_cond.add_component(parameter("HARMONICS")); + volumetric_surface_flow_cond.add_component(parameter("VAL")); + volumetric_surface_flow_cond.add_component(parameter("FUNCT")); + + volumetric_surface_flow_cond.add_component(one_of({ + selection( + "NORMAL", {"self_evaluate"}, {.description = "type of normal evaluation"}), + all_of({ + selection( + "NORMAL", {"use_prescribed"}, {.description = "type of normal evaluation"}), + parameter>("NVECTOR", {.size = 3}), + }), + })); + + volumetric_surface_flow_cond.add_component(one_of({ + selection( + "CENTEROFMASS", {"self_evaluate"}, {.description = "type of center of mass evaluation"}), + all_of({ + selection("CENTEROFMASS", {"use_prescribed"}, + {.description = "type of center of mass evaluation"}), + parameter>("CVECTOR", {.size = 3}), + }), + })); condlist.push_back(volumetric_surface_flow_cond); - /*--------------------------------------------------------------------*/ // Volumetric flow border nodes condition @@ -1574,38 +1578,41 @@ void Inpar::FLUID::set_valid_conditions( total_traction_correction_cond.add_component(parameter("ConditionID")); total_traction_correction_cond.add_component( - selection("ConditionType", {"POLYNOMIAL", "WOMERSLEY"}, - {.description = "condition type", .default_value = "POLYNOMIAL"})); + selection("CONDITIONTYPE", {"polynomial", "womersley"}, + {.description = "condition type", .default_value = "polynomial"})); total_traction_correction_cond.add_component( - selection("prebiased", {"NOTPREBIASED", "PREBIASED", "FORCED"}, - {.description = "prebiased", .default_value = "NOTPREBIASED"})); + selection("PREBIAS", {"not_prebiased", "prebiased", "forced"}, + {.description = "prebias type", .default_value = "not_prebiased"})); total_traction_correction_cond.add_component(selection( - "FlowType", {"InFlow", "OutFlow"}, {.description = "flow type", .default_value = "InFlow"})); - total_traction_correction_cond.add_component( - selection("CorrectionFlag", {"WithOutCorrection", "WithCorrection"}, - {.description = "correction flag", .default_value = "WithOutCorrection"})); + "FLOWTYPE", {"inflow", "outflow"}, {.description = "flow type", .default_value = "inflow"})); + total_traction_correction_cond.add_component(parameter( + "CORRECTPROFILE", {.description = "correction flag", .default_value = false})); - total_traction_correction_cond.add_component(parameter("Period")); - total_traction_correction_cond.add_component(parameter("Order")); - total_traction_correction_cond.add_component(parameter("Harmonics")); - total_traction_correction_cond.add_component(parameter("Val")); - total_traction_correction_cond.add_component(parameter("Funct")); + total_traction_correction_cond.add_component(parameter("PERIOD")); + total_traction_correction_cond.add_component(parameter("ORDER")); + total_traction_correction_cond.add_component(parameter("HARMONICS")); + total_traction_correction_cond.add_component(parameter("VAL")); + total_traction_correction_cond.add_component(parameter("FUNCT")); + + total_traction_correction_cond.add_component( + one_of({selection( + "NORMAL", {"self_evaluate"}, {.description = "type of normal evaluation"}), + all_of({ + selection( + "NORMAL", {"use_prescribed"}, {.description = "type of normal evaluation"}), + parameter>("NVECTOR", {.size = 3}), + })})); total_traction_correction_cond.add_component( - selection("NORMAL", {"SelfEvaluateNormal", "UsePrescribedNormal"}, - {.description = "normal", .default_value = "SelfEvaluateNormal"})); - total_traction_correction_cond.add_component(parameter("n1")); - total_traction_correction_cond.add_component(parameter("n2")); - total_traction_correction_cond.add_component(parameter("n3")); - - total_traction_correction_cond.add_component(selection("CenterOfMass", - {"SelfEvaluateCenterOfMass", "UsePrescribedCenterOfMass"}, - {.description = "center of mass", .default_value = "SelfEvaluateCenterOfMass"})); - total_traction_correction_cond.add_component(parameter("c1")); - total_traction_correction_cond.add_component(parameter("c2")); - total_traction_correction_cond.add_component(parameter("c3")); + one_of({selection("CENTEROFMASS", {"self_evaluate"}, + {.description = "type of center of mass evaluation"}), + all_of({ + selection("CENTEROFMASS", {"use_prescribed"}, + {.description = "type of center of mass evaluation"}), + parameter>("CVECTOR", {.size = 3}), + })})); condlist.push_back(total_traction_correction_cond); diff --git a/src/inpar/4C_inpar_structure.cpp b/src/inpar/4C_inpar_structure.cpp index eee52b5e6c..7b4a8ab37e 100644 --- a/src/inpar/4C_inpar_structure.cpp +++ b/src/inpar/4C_inpar_structure.cpp @@ -406,17 +406,17 @@ namespace Inpar "ONOFF", {.description = "", .size = from_parameter("NUMDOF")})); cond.add_component(parameter>( "STIFF", {.description = "", .size = from_parameter("NUMDOF")})); - cond.add_component(parameter>( + cond.add_component(parameter>>( "TIMEFUNCTSTIFF", {.description = "", .size = from_parameter("NUMDOF")})); cond.add_component(parameter>( "VISCO", {.description = "", .size = from_parameter("NUMDOF")})); - cond.add_component(parameter>( + cond.add_component(parameter>>( "TIMEFUNCTVISCO", {.description = "", .size = from_parameter("NUMDOF")})); cond.add_component(parameter>( "DISPLOFFSET", {.description = "", .size = from_parameter("NUMDOF")})); - cond.add_component(parameter>( + cond.add_component(parameter>>( "TIMEFUNCTDISPLOFFSET", {.description = "", .size = from_parameter("NUMDOF")})); - cond.add_component(parameter>( + cond.add_component(parameter>>( "FUNCTNONLINSTIFF", {.description = "", .size = from_parameter("NUMDOF")})); cond.add_component( selection("DIRECTION", diff --git a/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha.dat b/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha.dat index e465b35422..3230dee776 100644 --- a/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha.dat +++ b/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha.dat @@ -98,7 +98,7 @@ E 7 id 1 R_arvalve_max 1.0e1 R_arvalve_min 1.0e-6 R_atvalve_max 1.0e1 R_atvalve_ E 8 coupling_id 0 E 9 coupling_id 1 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF 0 VISCO 0.005 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none +E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF none VISCO 0.005 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none ---------------------------------------------------------DSURF-NODE TOPOLOGY NODE 1 DSURFACE 1 NODE 2 DSURFACE 1 diff --git a/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha_mor.dat b/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha_mor.dat index 97ee127365..ff1c460c61 100644 --- a/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha_mor.dat +++ b/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha_mor.dat @@ -64,7 +64,7 @@ E 7 id 1 R_arvalve_max 1.0e1 R_arvalve_min 1.0e-6 R_atvalve_max 1.0e1 R_atvalve_ E 8 coupling_id 0 E 9 coupling_id 1 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF 0 VISCO 0.005 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none +E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF none VISCO 0.005 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none ---------------------------------------------------------DSURF-NODE TOPOLOGY NODE 1 DSURFACE 1 NODE 2 DSURFACE 1 diff --git a/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha_new_struc.dat b/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha_new_struc.dat index 08946af171..b73d235a68 100644 --- a/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha_new_struc.dat +++ b/tests/input_files/cardiovascular0d_arterialproxdist_structure_direct_genalpha_new_struc.dat @@ -122,7 +122,7 @@ E 7 id 1 R_arvalve_max 1.0e1 R_arvalve_min 1.0e-6 R_atvalve_max 1.0e1 R_atvalve_ E 8 coupling_id 0 E 9 coupling_id 1 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF 0 VISCO 0.005 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none +E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF none VISCO 0.005 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none ---------------------------------------------------------DSURF-NODE TOPOLOGY NODE 1 DSURFACE 1 NODE 2 DSURFACE 1 diff --git a/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_direct_genalpha.dat b/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_direct_genalpha.dat index 84499731bc..737aaf6f1d 100644 --- a/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_direct_genalpha.dat +++ b/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_direct_genalpha.dat @@ -171,7 +171,7 @@ E 7 id 1 TYPE ventricle_right E 8 coupling_id 0 E 9 coupling_id 1 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF 0 VISCO 0.005 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none +E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF none VISCO 0.005 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none ---------------------------------------------------------DSURF-NODE TOPOLOGY NODE 1 DSURFACE 1 NODE 2 DSURFACE 1 diff --git a/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_simple_genalpha.dat b/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_simple_genalpha.dat index 2f34369b2c..d12a1a16e7 100644 --- a/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_simple_genalpha.dat +++ b/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_simple_genalpha.dat @@ -198,7 +198,7 @@ E 7 id 1 TYPE ventricle_right E 8 coupling_id 0 E 9 coupling_id 1 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF 0 VISCO 0.005 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none +E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF none VISCO 0.005 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none ---------------------------------------------------------DSURF-NODE TOPOLOGY NODE 1 DSURFACE 1 NODE 2 DSURFACE 1 diff --git a/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_statprestress.dat b/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_statprestress.dat index 54cde0e42d..f153645238 100644 --- a/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_statprestress.dat +++ b/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structure_statprestress.dat @@ -99,7 +99,7 @@ E 3 NUMDOF 3 ONOFF 1 1 0 VAL 0.0 0.0 0.0 FUNCT 0 0 0 E 6 ConditionID 0 E 7 ConditionID 1 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF 0 VISCO 0.005 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none +E 4 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF none VISCO 0.005 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none ---------------------------------------------------------DSURF-NODE TOPOLOGY NODE 1 DSURFACE 1 NODE 2 DSURFACE 1 diff --git a/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structurecontactpenalty_direct_genalpha.dat b/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structurecontactpenalty_direct_genalpha.dat index 047a79588b..f87ed9b3b4 100644 --- a/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structurecontactpenalty_direct_genalpha.dat +++ b/tests/input_files/cardiovascular0d_syspulcirculation_2chamber_structurecontactpenalty_direct_genalpha.dat @@ -216,8 +216,8 @@ E 7 id 1 TYPE ventricle_right E 8 coupling_id 0 E 9 coupling_id 1 -----------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 2 NUMDOF 1 ONOFF 1 STIFF 1.5 TIMEFUNCTSTIFF 0 VISCO 0.001 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 3 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF 0 VISCO 0.005 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none +E 2 NUMDOF 1 ONOFF 1 STIFF 1.5 TIMEFUNCTSTIFF none VISCO 0.001 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 3 NUMDOF 1 ONOFF 1 STIFF 0.075 TIMEFUNCTSTIFF none VISCO 0.005 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none -----------------------------------------------DSURF-NODE TOPOLOGY NODE 1 DSURFACE 1 NODE 2 DSURFACE 1 diff --git a/tests/input_files/cardiovascular0d_syspulcirculation_4chamber_structure_simple_genalpha.dat b/tests/input_files/cardiovascular0d_syspulcirculation_4chamber_structure_simple_genalpha.dat index 61056def36..2536d325ae 100644 --- a/tests/input_files/cardiovascular0d_syspulcirculation_4chamber_structure_simple_genalpha.dat +++ b/tests/input_files/cardiovascular0d_syspulcirculation_4chamber_structure_simple_genalpha.dat @@ -176,12 +176,12 @@ E 9 coupling_id 1 E 2 coupling_id 2 E 4 coupling_id 3 ---------------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 12 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 13 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 5 NUMDOF 3 ONOFF 1 1 1 STIFF 0.1 0.1 0.1 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0005 0.0005 0.0005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 14 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 15 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 16 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 12 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 13 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 5 NUMDOF 3 ONOFF 1 1 1 STIFF 0.1 0.1 0.1 TIMEFUNCTSTIFF none none none VISCO 0.0005 0.0005 0.0005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 14 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 15 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 16 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none ---------------------------------------------------------DLINE-NODE TOPOLOGY NODE 512 DLINE 1 NODE 695 DLINE 1 diff --git a/tests/input_files/cardiovascular0d_syspulcirculation_4chamber_structure_simple_genalpha_new_struc.dat b/tests/input_files/cardiovascular0d_syspulcirculation_4chamber_structure_simple_genalpha_new_struc.dat index 1c4c9b392b..4c630d77b1 100644 --- a/tests/input_files/cardiovascular0d_syspulcirculation_4chamber_structure_simple_genalpha_new_struc.dat +++ b/tests/input_files/cardiovascular0d_syspulcirculation_4chamber_structure_simple_genalpha_new_struc.dat @@ -209,12 +209,12 @@ E 9 coupling_id 1 E 2 coupling_id 2 E 4 coupling_id 3 ---------------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 12 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 13 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 5 NUMDOF 3 ONOFF 1 1 1 STIFF 0.1 0.1 0.1 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0005 0.0005 0.0005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 14 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 15 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 16 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 12 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 13 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 5 NUMDOF 3 ONOFF 1 1 1 STIFF 0.1 0.1 0.1 TIMEFUNCTSTIFF none none none VISCO 0.0005 0.0005 0.0005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 14 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 15 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 16 NUMDOF 3 ONOFF 1 1 1 STIFF 2.0 2.0 2.0 TIMEFUNCTSTIFF none none none VISCO 0.005 0.005 0.005 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none ---------------------------------------------------------DLINE-NODE TOPOLOGY NODE 512 DLINE 1 NODE 695 DLINE 1 diff --git a/tests/input_files/f3_artery_coupled_with_3_1d_arteries.dat b/tests/input_files/f3_artery_coupled_with_3_1d_arteries.dat index 5d6176ec66..cfb1abaae0 100644 --- a/tests/input_files/f3_artery_coupled_with_3_1d_arteries.dat +++ b/tests/input_files/f3_artery_coupled_with_3_1d_arteries.dat @@ -85,7 +85,7 @@ E 1 NUMDOF 4 ONOFF 1 1 1 0 VAL 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 -----------------------------------------------DESIGN SURF DIRICH CONDITIONS E 1 NUMDOF 4 ONOFF 1 1 1 0 VAL 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 --------------------------------------DESIGN SURF VOLUMETRIC FLOW CONDITIONS -E 2 ConditionID 1 ConditionType POLYNOMIAL prebiased FORCED FlowType InFlow CorrectionFlag WithCorrection Period 1.0 Order 2 Harmonics 16 Val 1.0 Funct 1 NORMAL SelfEvaluateNormal n1 0.0 n2 0.0 n3 1.0 CenterOfMass SelfEvaluateCenterOfMass c1 0.0 c2 0.0 c3 0.0 +E 2 ConditionID 1 CONDITIONTYPE polynomial PREBIAS forced FLOWTYPE inflow CORRECTPROFILE true PERIOD 1.0 ORDER 2 HARMONICS 16 VAL 1.0 FUNCT 1 NORMAL self_evaluate CENTEROFMASS self_evaluate ------------------------------------DESIGN LINE VOLUMETRIC FLOW BORDER NODES E 1 ConditionID 1 ----------------------------------DESIGN NODE 1D ARTERY IN_OUTLET CONDITIONS @@ -115,7 +115,7 @@ E 25 VAL 0.0 curve none ----------------------------------------FLUID NEUMANN INFLOW SURF CONDITIONS E 3 ------------------DESIGN SURF TOTAL TRACTION CORRECTION CONDITIONS -E 3 ConditionID 2 ConditionType POLYNOMIAL prebiased NOTPREBIASED FlowType OutFlow CorrectionFlag WithOutCorrection Period 1.0 Order 2 Harmonics 16 Val 1.0 Funct 1 NORMAL SelfEvaluateNormal n1 0.0 n2 0.0 n3 1.0 CenterOfMass SelfEvaluateCenterOfMass c1 0.0 c2 0.0 c3 0.0 +E 3 ConditionID 2 CONDITIONTYPE polynomial PREBIAS not_prebiased FLOWTYPE outflow CORRECTPROFILE false PERIOD 1.0 ORDER 2 HARMONICS 16 VAL 1.0 FUNCT 1 NORMAL self_evaluate CENTEROFMASS self_evaluate ----------------DESIGN LINE TOTAL TRACTION CORRECTION BORDER NODES E 2 ConditionID 2 ---------------------------------------------------------DNODE-NODE TOPOLOGY diff --git a/tests/input_files/f3_pseudo_orthopressure.dat b/tests/input_files/f3_pseudo_orthopressure.dat index f411b41239..167e691ca4 100644 --- a/tests/input_files/f3_pseudo_orthopressure.dat +++ b/tests/input_files/f3_pseudo_orthopressure.dat @@ -86,7 +86,7 @@ E 3 E 3 NUMDOF 3 ONOFF 1 0 0 VAL 100.0 0.0 0.0 FUNCT 1 0 0 TYPE pseudo_orthopressure //E 3 - NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 100.0 FUNCT 1 0 0 TYPE Live //does the same as the previous line, since in this case the normal direction is the z-direction --------------------------------------DESIGN SURF VOLUMETRIC FLOW CONDITIONS -E 1 ConditionID 1 ConditionType WOMERSLEY prebiased NOTPREBIASED FlowType InFlow CorrectionFlag WithCorrection Period 1.0 Order 2 Harmonics 16 Val -10000.0 Funct 2 NORMAL SelfEvaluateNormal n1 0.0 n2 0.0 n3 0.0 CenterOfMass SelfEvaluateCenterOfMass c1 0.0 c2 0.0 c3 0.0 +E 1 ConditionID 1 CONDITIONTYPE womersley PREBIAS not_prebiased FLOWTYPE inflow CORRECTPROFILE true PERIOD 1.0 ORDER 2 HARMONICS 16 VAL -10000.0 FUNCT 2 NORMAL self_evaluate CENTEROFMASS self_evaluate ------------------------------------DESIGN LINE VOLUMETRIC FLOW BORDER NODES E 1 ConditionID 1 ---------------------------------------------------------DLINE-NODE TOPOLOGY diff --git a/tests/input_files/f3_womersley.dat b/tests/input_files/f3_womersley.dat index 1035801f96..4181ac79e1 100644 --- a/tests/input_files/f3_womersley.dat +++ b/tests/input_files/f3_womersley.dat @@ -111,9 +111,9 @@ E 2 NUMDOF 4 ONOFF 1 1 1 0 VAL 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 ----------------------------------------FLUID NEUMANN INFLOW SURF CONDITIONS E 3 --------------------------------------------DESIGN SURF IMPEDANCE CONDITIONS -E 3 ConditionID 1 TYPE windkessel R1 0.11 R2 2.2 C 0.6 TIMEPERIOD 1.0 FUNCT -1 +E 3 ConditionID 1 TYPE windkessel R1 0.11 R2 2.2 C 0.6 TIMEPERIOD 1.0 FUNCT none --------------------------------------DESIGN SURF VOLUMETRIC FLOW CONDITIONS -E 1 ConditionID 1 ConditionType POLYNOMIAL prebiased PREBIASED FlowType InFlow CorrectionFlag WithCorrection Period 1.0 Order 2 Harmonics 16 Val -8261.0 Funct 1 NORMAL SelfEvaluateNormal n1 0.0 n2 0.0 n3 0.0 CenterOfMass SelfEvaluateCenterOfMass c1 0.0 c2 0.0 c3 0.0 +E 1 ConditionID 1 CONDITIONTYPE polynomial PREBIAS prebiased FLOWTYPE inflow CORRECTPROFILE true PERIOD 1.0 ORDER 2 HARMONICS 16 VAL -8261.0 FUNCT 1 NORMAL self_evaluate CENTEROFMASS self_evaluate ------------------------------------DESIGN LINE VOLUMETRIC FLOW BORDER NODES E 1 ConditionID 1 ---------------------------------------------------------DLINE-NODE TOPOLOGY diff --git a/tests/input_files/fs3i_mult_scalar_windkessel_reac.dat b/tests/input_files/fs3i_mult_scalar_windkessel_reac.dat index 30e74b7565..a2fbf44c3b 100644 --- a/tests/input_files/fs3i_mult_scalar_windkessel_reac.dat +++ b/tests/input_files/fs3i_mult_scalar_windkessel_reac.dat @@ -349,11 +349,11 @@ E 1 NUMDOF 4 ONOFF 1 1 1 0 VAL 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 E 2 NUMDOF 4 ONOFF 1 1 1 0 VAL 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 -----------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS // structure_wall_all -E 13 NUMDOF 1 ONOFF 1 STIFF 50000.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 13 NUMDOF 3 ONOFF 1 1 1 STIFF 5000.0 5000.0 5000.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 13 NUMDOF 1 ONOFF 1 STIFF 50000.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 13 NUMDOF 3 ONOFF 1 1 1 STIFF 5000.0 5000.0 5000.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none ----------------------------------DESIGN SURF IMPEDANCE CONDITIONS // fluid_outflow_all -E 3 ConditionID 1 TYPE windkessel R1 0.01 R2 0.01 C 0.01 TIMEPERIOD 1.0 FUNCT -1 +E 3 ConditionID 1 TYPE windkessel R1 0.01 R2 0.01 C 0.01 TIMEPERIOD 1.0 FUNCT none --------------------------FLUID NEUMANN INFLOW SURF CONDITIONS // fluid_outflow_all E 3 diff --git a/tests/input_files/fsi_artery_coupled_0d_3d_0d.dat b/tests/input_files/fsi_artery_coupled_0d_3d_0d.dat index fbc2dd0d43..8f1af6b673 100644 --- a/tests/input_files/fsi_artery_coupled_0d_3d_0d.dat +++ b/tests/input_files/fsi_artery_coupled_0d_3d_0d.dat @@ -101,9 +101,9 @@ E 1 boundarycond flow VAL 1.5E4 curve 1 0 E 4 boundarycond pressure VAL 0.0 curve 1 0 ------------------DESIGN SURF TOTAL TRACTION CORRECTION CONDITIONS // fluid_inflow_surf -E 1 ConditionID 1 ConditionType POLYNOMIAL prebiased NOTPREBIASED FlowType InFlow CorrectionFlag WithOutCorrection Period 1.0 Order 2 Harmonics 32 Val 1.5E4 Funct 1 NORMAL SelfEvaluateNormal n1 0.0 n2 0.0 n3 1.0 CenterOfMass SelfEvaluateCenterOfMass c1 0.0 c2 0.0 c3 0.0 +E 1 ConditionID 1 CONDITIONTYPE polynomial PREBIAS not_prebiased FLOWTYPE inflow CORRECTPROFILE false PERIOD 1.0 ORDER 2 HARMONICS 32 VAL 1.5E4 FUNCT 1 NORMAL self_evaluate CENTEROFMASS self_evaluate // fluid_outflow_surf -E 2 ConditionID 2 ConditionType POLYNOMIAL prebiased NOTPREBIASED FlowType OutFlow CorrectionFlag WithOutCorrection Period 1.0 Order 2 Harmonics 32 Val 1.5E4 Funct 1 NORMAL SelfEvaluateNormal n1 0.0 n2 0.0 n3 1.0 CenterOfMass SelfEvaluateCenterOfMass c1 0.0 c2 0.0 c3 0.0 +E 2 ConditionID 2 CONDITIONTYPE polynomial PREBIAS not_prebiased FLOWTYPE outflow CORRECTPROFILE false PERIOD 1.0 ORDER 2 HARMONICS 32 VAL 1.5E4 FUNCT 1 NORMAL self_evaluate CENTEROFMASS self_evaluate ----------------DESIGN LINE TOTAL TRACTION CORRECTION BORDER NODES // fluid_inflow_ring_NoDBC_slave E 1 ConditionID 1 diff --git a/tests/input_files/homogenized-constrained-mixture-cube-aniso-expl.dat b/tests/input_files/homogenized-constrained-mixture-cube-aniso-expl.dat index 72a9198da5..cd0951a80a 100644 --- a/tests/input_files/homogenized-constrained-mixture-cube-aniso-expl.dat +++ b/tests/input_files/homogenized-constrained-mixture-cube-aniso-expl.dat @@ -56,7 +56,7 @@ MAT 121 ELAST_IsoExpoPow K1 10 K2 10 C 1 MAT 122 ELAST_VolSussmanBathe KAPPA 100 MAT 129 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0.0 0.0 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/homogenized-constrained-mixture-cube-iso-expl.dat b/tests/input_files/homogenized-constrained-mixture-cube-iso-expl.dat index f2db289db8..4eedff7da6 100644 --- a/tests/input_files/homogenized-constrained-mixture-cube-iso-expl.dat +++ b/tests/input_files/homogenized-constrained-mixture-cube-iso-expl.dat @@ -56,7 +56,7 @@ MAT 121 ELAST_IsoExpoPow K1 10 K2 10 C 1 MAT 122 ELAST_VolSussmanBathe KAPPA 100 MAT 129 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0.0 0.0 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/homogenized-constrained-mixture-cube-stiffness-expl.dat b/tests/input_files/homogenized-constrained-mixture-cube-stiffness-expl.dat index 284465ce06..8ad8e7c72a 100644 --- a/tests/input_files/homogenized-constrained-mixture-cube-stiffness-expl.dat +++ b/tests/input_files/homogenized-constrained-mixture-cube-stiffness-expl.dat @@ -55,7 +55,7 @@ MAT 12 MIX_Constituent_ElastHyper NUMMAT 1 MATIDS 121 PRESTRESS_STRATEGY 129 MAT 121 ELAST_IsoExpoPow K1 10 K2 10 C 1 MAT 129 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0.0 0.0 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/homogenized-constrained-mixture-cube-stiffness-impl.dat b/tests/input_files/homogenized-constrained-mixture-cube-stiffness-impl.dat index 14d6d214ff..a230ff78e3 100644 --- a/tests/input_files/homogenized-constrained-mixture-cube-stiffness-impl.dat +++ b/tests/input_files/homogenized-constrained-mixture-cube-stiffness-impl.dat @@ -55,7 +55,7 @@ MAT 12 MIX_Constituent_ElastHyper NUMMAT 1 MATIDS 121 PRESTRESS_STRATEGY 129 MAT 121 ELAST_IsoExpoPow K1 10 K2 10 C 1 MAT 129 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0.0 0.0 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/mixture_growth_expl_remodel_fiber_no_basal_mass_production.dat b/tests/input_files/mixture_growth_expl_remodel_fiber_no_basal_mass_production.dat index 59161394eb..069dadab00 100644 --- a/tests/input_files/mixture_growth_expl_remodel_fiber_no_basal_mass_production.dat +++ b/tests/input_files/mixture_growth_expl_remodel_fiber_no_basal_mass_production.dat @@ -63,7 +63,7 @@ MAT 131 ELAST_IsoExpoPow K1 10 K2 10 C 1 MAT 132 ELAST_VolSussmanBathe KAPPA 100 MAT 139 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0.0 0.0 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 100.0 0.0 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/mixture_growth_full_constrained_mixture_fiber_adaptive_higher_order.dat b/tests/input_files/mixture_growth_full_constrained_mixture_fiber_adaptive_higher_order.dat index 4355fc2c10..0e1689a17a 100644 --- a/tests/input_files/mixture_growth_full_constrained_mixture_fiber_adaptive_higher_order.dat +++ b/tests/input_files/mixture_growth_full_constrained_mixture_fiber_adaptive_higher_order.dat @@ -62,7 +62,7 @@ MAT 129 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0 -------------------------------------------------------------------FUNCT1 COMPONENT 0 SYMBOLIC_FUNCTION_OF_SPACE_TIME 1+0.05*y+0.04*z ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/mixture_growth_full_constrained_mixture_fiber_adaptive_model_equation.dat b/tests/input_files/mixture_growth_full_constrained_mixture_fiber_adaptive_model_equation.dat index 9f0cbf15c9..ef0bfec97f 100644 --- a/tests/input_files/mixture_growth_full_constrained_mixture_fiber_adaptive_model_equation.dat +++ b/tests/input_files/mixture_growth_full_constrained_mixture_fiber_adaptive_model_equation.dat @@ -63,7 +63,7 @@ MAT 129 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0 -------------------------------------------------------------------FUNCT1 COMPONENT 0 SYMBOLIC_FUNCTION_OF_SPACE_TIME 1+0.2*y+0.4*z ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/mixture_growth_full_constrained_mixture_fiber_no_basal_mass_production.dat b/tests/input_files/mixture_growth_full_constrained_mixture_fiber_no_basal_mass_production.dat index e7cb659f07..e033794764 100644 --- a/tests/input_files/mixture_growth_full_constrained_mixture_fiber_no_basal_mass_production.dat +++ b/tests/input_files/mixture_growth_full_constrained_mixture_fiber_no_basal_mass_production.dat @@ -63,7 +63,7 @@ MAT 131 ELAST_IsoExpoPow K1 10 K2 10 C 1 MAT 132 ELAST_VolSussmanBathe KAPPA 100 MAT 139 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0.0 0.0 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 100.0 0.0 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/mixture_growth_full_constrained_mixture_fiber_non_adaptive.dat b/tests/input_files/mixture_growth_full_constrained_mixture_fiber_non_adaptive.dat index 3c56ba1606..8b244cd7e8 100644 --- a/tests/input_files/mixture_growth_full_constrained_mixture_fiber_non_adaptive.dat +++ b/tests/input_files/mixture_growth_full_constrained_mixture_fiber_non_adaptive.dat @@ -62,7 +62,7 @@ MAT 129 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0 -------------------------------------------------------------------FUNCT1 COMPONENT 0 SYMBOLIC_FUNCTION_OF_SPACE_TIME 1+0.2*y+0.4*z ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/mixture_growth_impl_remodel_fiber_no_basal_mass_production.dat b/tests/input_files/mixture_growth_impl_remodel_fiber_no_basal_mass_production.dat index 52bb3b4daa..f05894392b 100644 --- a/tests/input_files/mixture_growth_impl_remodel_fiber_no_basal_mass_production.dat +++ b/tests/input_files/mixture_growth_impl_remodel_fiber_no_basal_mass_production.dat @@ -63,7 +63,7 @@ MAT 131 ELAST_IsoExpoPow K1 10 K2 10 C 1 MAT 132 ELAST_VolSussmanBathe KAPPA 100 MAT 139 MIX_Prestress_Strategy_Constant PRESTRETCH 1.0 1.0 1.0 0.0 0.0 0.0 0.0 0.0 0.0 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 100.0 0.0 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/mixture_prestress_isochoric_spring_dashpot.dat b/tests/input_files/mixture_prestress_isochoric_spring_dashpot.dat index 468fbd29a7..d98efc7360 100644 --- a/tests/input_files/mixture_prestress_isochoric_spring_dashpot.dat +++ b/tests/input_files/mixture_prestress_isochoric_spring_dashpot.dat @@ -68,7 +68,7 @@ VARIABLE 0 NAME a TYPE linearinterpolation NUMPOINTS 3 TIMES 0 1 9999999999.0 VA COMPONENT 0 SYMBOLIC_FUNCTION_OF_SPACE_TIME a VARIABLE 0 NAME a TYPE linearinterpolation NUMPOINTS 3 TIMES 0 1.0 9999999999.0 VALUES 0 1 1 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 100.0 0.0 0.0 0.0 0.0 0.0 FUNCT 2 0 0 0 0 0 -------------------------------------DESIGN SURF DIRICH CONDITIONS diff --git a/tests/input_files/mixture_prestress_isochoric_spring_dashpot_restart_from_prestress.dat b/tests/input_files/mixture_prestress_isochoric_spring_dashpot_restart_from_prestress.dat index 66b588a805..bafcecdac1 100644 --- a/tests/input_files/mixture_prestress_isochoric_spring_dashpot_restart_from_prestress.dat +++ b/tests/input_files/mixture_prestress_isochoric_spring_dashpot_restart_from_prestress.dat @@ -58,7 +58,7 @@ MAT 14 MIX_Constituent_ElastHyper NUMMAT 1 MATIDS 141 PRESTRESS_STRATEGY 149 MAT 141 ELAST_IsoExpoPow K1 10 K2 10 C 1 MAT 149 MIX_Prestress_Strategy_Iterative ACTIVE false ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 0 0 -------------------------------------DESIGN SURF DIRICH CONDITIONS diff --git a/tests/input_files/mixture_prestress_spring_dashpot.dat b/tests/input_files/mixture_prestress_spring_dashpot.dat index 3ae81c7986..b726f35e17 100644 --- a/tests/input_files/mixture_prestress_spring_dashpot.dat +++ b/tests/input_files/mixture_prestress_spring_dashpot.dat @@ -63,7 +63,7 @@ VARIABLE 0 NAME a TYPE linearinterpolation NUMPOINTS 3 TIMES 0 1 9999999999.0 VA COMPONENT 0 SYMBOLIC_FUNCTION_OF_SPACE_TIME a VARIABLE 0 NAME a TYPE linearinterpolation NUMPOINTS 3 TIMES 0 1.0 9999999999.0 VALUES 0 1 1 ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10 10.0 10.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10 10.0 10.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 100.0 0.0 0.0 0.0 0.0 0.0 FUNCT 2 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/mixture_prestress_spring_dashpot_restart_from_prestress.dat b/tests/input_files/mixture_prestress_spring_dashpot_restart_from_prestress.dat index 3edab53406..78e4a6b966 100644 --- a/tests/input_files/mixture_prestress_spring_dashpot_restart_from_prestress.dat +++ b/tests/input_files/mixture_prestress_spring_dashpot_restart_from_prestress.dat @@ -53,7 +53,7 @@ MAT 141 ELAST_IsoExpoPow K1 10 K2 10 C 1 MAT 143 ELAST_VolSussmanBathe KAPPA 100 MAT 149 MIX_Prestress_Strategy_Iterative ACTIVE false ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10 10.0 10.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10 10.0 10.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 100.0 0.0 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/solid_material_prestress_iterative_spring_dashpot.4C.yaml b/tests/input_files/solid_material_prestress_iterative_spring_dashpot.4C.yaml index 76b782a75c..7038d6f40e 100644 --- a/tests/input_files/solid_material_prestress_iterative_spring_dashpot.4C.yaml +++ b/tests/input_files/solid_material_prestress_iterative_spring_dashpot.4C.yaml @@ -64,12 +64,12 @@ DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS: NUMDOF: 3 ONOFF: [1, 1, 1] STIFF: [10, 0.001, 0.001] - TIMEFUNCTSTIFF: [0, 0, 0] + TIMEFUNCTSTIFF: [null, null, null] VISCO: [0, 0, 0] - TIMEFUNCTVISCO: [0, 0, 0] + TIMEFUNCTVISCO: [null, null, null] DISPLOFFSET: [0, 0, 0] - TIMEFUNCTDISPLOFFSET: [0, 0, 0] - FUNCTNONLINSTIFF: [0, 0, 0] + TIMEFUNCTDISPLOFFSET: [null, null, null] + FUNCTNONLINSTIFF: [null, null, null] DIRECTION: xyz COUPLING: null DESIGN SURF NEUMANN CONDITIONS: diff --git a/tests/input_files/solid_runtime_gauss_point_quantity_output_element_center.dat b/tests/input_files/solid_runtime_gauss_point_quantity_output_element_center.dat index a4c8e5f235..190868ab35 100644 --- a/tests/input_files/solid_runtime_gauss_point_quantity_output_element_center.dat +++ b/tests/input_files/solid_runtime_gauss_point_quantity_output_element_center.dat @@ -64,7 +64,7 @@ MAT 22 ELAST_VolSussmanBathe KAPPA 1000 -------------------------------------------------------------------FUNCT1 COMPONENT 0 SYMBOLIC_FUNCTION_OF_SPACE_TIME 1+0.2*y+0.4*z ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/solid_runtime_gauss_point_quantity_output_gauss_point.dat b/tests/input_files/solid_runtime_gauss_point_quantity_output_gauss_point.dat index d5fe778002..44a4a012c5 100644 --- a/tests/input_files/solid_runtime_gauss_point_quantity_output_gauss_point.dat +++ b/tests/input_files/solid_runtime_gauss_point_quantity_output_gauss_point.dat @@ -64,7 +64,7 @@ MAT 22 ELAST_VolSussmanBathe KAPPA 1000 -------------------------------------------------------------------FUNCT1 COMPONENT 0 SYMBOLIC_FUNCTION_OF_SPACE_TIME 1+0.2*y+0.4*z ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/solid_runtime_gauss_point_quantity_output_nodal.dat b/tests/input_files/solid_runtime_gauss_point_quantity_output_nodal.dat index 12aafbb819..d7cb8f7075 100644 --- a/tests/input_files/solid_runtime_gauss_point_quantity_output_nodal.dat +++ b/tests/input_files/solid_runtime_gauss_point_quantity_output_nodal.dat @@ -63,7 +63,7 @@ MAT 22 ELAST_VolSussmanBathe KAPPA 1000 -------------------------------------------------------------------FUNCT1 COMPONENT 0 SYMBOLIC_FUNCTION_OF_SPACE_TIME 1+0.2*y+0.4*z ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/solid_runtime_gauss_point_quantity_output_result_test.dat b/tests/input_files/solid_runtime_gauss_point_quantity_output_result_test.dat index 723cbfcf1a..918bef55bf 100644 --- a/tests/input_files/solid_runtime_gauss_point_quantity_output_result_test.dat +++ b/tests/input_files/solid_runtime_gauss_point_quantity_output_result_test.dat @@ -65,7 +65,7 @@ MAT 22 ELAST_VolSussmanBathe KAPPA 1000 -------------------------------------------------------------------FUNCT1 COMPONENT 0 SYMBOLIC_FUNCTION_OF_SPACE_TIME 1+0.2*y+0.4*z ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 100.0 100.0 100.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET -1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 150.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 0 0 0 0 0 ------------------------------------------------------------RESULT DESCRIPTION diff --git a/tests/input_files/spring_dashpot_prestress_new.dat b/tests/input_files/spring_dashpot_prestress_new.dat index cfa99e9425..cbf4ef2a12 100644 --- a/tests/input_files/spring_dashpot_prestress_new.dat +++ b/tests/input_files/spring_dashpot_prestress_new.dat @@ -56,7 +56,7 @@ LINEAR_SOLVER 1 --------------------------------------------------------------------SOLVER 1 SOLVER UMFPACK ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10.0 10.0 10.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10.0 10.0 10.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none ----------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 1 1 0 0 0 VAL 1.0 1.0 1.0 0.0 0.0 0.0 FUNCT 1 2 3 1 1 1 TYPE Live -------------------------------------------------------------------MATERIALS diff --git a/tests/input_files/spring_dashpot_prestress_old.dat b/tests/input_files/spring_dashpot_prestress_old.dat index 7f83fd85a8..ab16b567e9 100644 --- a/tests/input_files/spring_dashpot_prestress_old.dat +++ b/tests/input_files/spring_dashpot_prestress_old.dat @@ -56,7 +56,7 @@ LINEAR_SOLVER 1 --------------------------------------------------------------------SOLVER 1 SOLVER UMFPACK ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10.0 10.0 10.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 3 ONOFF 1 1 1 STIFF 10.0 10.0 10.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none ----------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 2 NUMDOF 6 ONOFF 1 1 1 0 0 0 VAL 1.0 1.0 1.0 0.0 0.0 0.0 FUNCT 1 2 3 1 1 1 TYPE Live -------------------------------------------------------------------MATERIALS diff --git a/tests/input_files/spring_dashpot_sohex8_new.dat b/tests/input_files/spring_dashpot_sohex8_new.dat index a6f408f27c..dce988f30b 100644 --- a/tests/input_files/spring_dashpot_sohex8_new.dat +++ b/tests/input_files/spring_dashpot_sohex8_new.dat @@ -64,18 +64,18 @@ E 22 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.25 0.0 FUNCT 1 1 1 E 23 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.2 FUNCT 1 1 1 E 24 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.25 FUNCT 1 1 1 ------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 1.0 0.0 0.0 TIMEFUNCTSTIFF 2 0 0 VISCO 1.0 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 3 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 1.0 0.0 TIMEFUNCTSTIFF 0 2 0 VISCO 0.0 1.0 0.0 TIMEFUNCTVISCO 0 2 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET 0 2 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 5 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 1.0 TIMEFUNCTSTIFF 0 0 2 VISCO 0.0 0.0 1.0 TIMEFUNCTVISCO 0 0 2 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET 0 0 2 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 7 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 9 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 11 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 13 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 1.0 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 3 0 0 DIRECTION xyz COUPLING none -E 15 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 1.0 0.0 TIMEFUNCTVISCO 0 2 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET 0 2 0 FUNCTNONLINSTIFF 0 4 0 DIRECTION xyz COUPLING none -E 17 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 1.0 TIMEFUNCTVISCO 0 0 2 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET 0 0 2 FUNCTNONLINSTIFF 0 0 5 DIRECTION xyz COUPLING none -E 19 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -E 21 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -E 23 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 1.0 0.0 0.0 TIMEFUNCTSTIFF 2 0 0 VISCO 1.0 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 3 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 1.0 0.0 TIMEFUNCTSTIFF none 2 0 VISCO 0.0 1.0 0.0 TIMEFUNCTVISCO none 2 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET none 2 0 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 5 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 1.0 TIMEFUNCTSTIFF none 0 2 VISCO 0.0 0.0 1.0 TIMEFUNCTVISCO none 0 2 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET none 0 2 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 7 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 9 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 11 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 13 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 1.0 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 3 0 0 DIRECTION xyz COUPLING none +E 15 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 1.0 0.0 TIMEFUNCTVISCO none 2 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET none 2 0 FUNCTNONLINSTIFF none 4 0 DIRECTION xyz COUPLING none +E 17 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 1.0 TIMEFUNCTVISCO none 0 2 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET none 0 2 FUNCTNONLINSTIFF none 0 5 DIRECTION xyz COUPLING none +E 19 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 21 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 23 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -------------------------------------------------------RESULT DESCRIPTION // result tests on cube 1 STRUCTURE DIS structure NODE 1 QUANTITY dispx VALUE 2.03775989030959781e-01 TOLERANCE 1e-9 diff --git a/tests/input_files/spring_dashpot_sohex8_old.dat b/tests/input_files/spring_dashpot_sohex8_old.dat index 5ae08a35b1..1cdb2111c6 100644 --- a/tests/input_files/spring_dashpot_sohex8_old.dat +++ b/tests/input_files/spring_dashpot_sohex8_old.dat @@ -64,18 +64,18 @@ E 22 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.25 0.0 FUNCT 1 1 1 E 23 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.2 FUNCT 1 1 1 E 24 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.25 FUNCT 1 1 1 ------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 1.0 0.0 0.0 TIMEFUNCTSTIFF 2 0 0 VISCO 1.0 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 3 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 1.0 0.0 TIMEFUNCTSTIFF 0 2 0 VISCO 0.0 1.0 0.0 TIMEFUNCTVISCO 0 2 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET 0 2 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 5 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 1.0 TIMEFUNCTSTIFF 0 0 2 VISCO 0.0 0.0 1.0 TIMEFUNCTVISCO 0 0 2 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET 0 0 2 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 7 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 9 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 11 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 13 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 1.0 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 3 0 0 DIRECTION xyz COUPLING none -E 15 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 1.0 0.0 TIMEFUNCTVISCO 0 2 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET 0 2 0 FUNCTNONLINSTIFF 0 4 0 DIRECTION xyz COUPLING none -E 17 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 1.0 TIMEFUNCTVISCO 0 0 2 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET 0 0 2 FUNCTNONLINSTIFF 0 0 5 DIRECTION xyz COUPLING none -E 19 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -E 21 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -E 23 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 1.0 0.0 0.0 TIMEFUNCTSTIFF 2 0 0 VISCO 1.0 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 3 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 1.0 0.0 TIMEFUNCTSTIFF none 2 0 VISCO 0.0 1.0 0.0 TIMEFUNCTVISCO none 2 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET none 2 0 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 5 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 1.0 TIMEFUNCTSTIFF none 0 2 VISCO 0.0 0.0 1.0 TIMEFUNCTVISCO none 0 2 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET none 0 2 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 7 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 9 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 11 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 13 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 1.0 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 3 0 0 DIRECTION xyz COUPLING none +E 15 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 1.0 0.0 TIMEFUNCTVISCO none 2 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET none 2 0 FUNCTNONLINSTIFF none 4 0 DIRECTION xyz COUPLING none +E 17 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 1.0 TIMEFUNCTVISCO none 0 2 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET none 0 2 FUNCTNONLINSTIFF none 0 5 DIRECTION xyz COUPLING none +E 19 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 21 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 23 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 1.0 TIMEFUNCTVISCO 2 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -------------------------------------------------------RESULT DESCRIPTION // result tests on cube 1 STRUCTURE DIS structure NODE 1 QUANTITY dispx VALUE 2.03775989030959781e-01 TOLERANCE 1e-9 diff --git a/tests/input_files/spring_dashpot_sohex8_prestress_new.dat b/tests/input_files/spring_dashpot_sohex8_prestress_new.dat index 970f8b75b7..096784ba07 100644 --- a/tests/input_files/spring_dashpot_sohex8_prestress_new.dat +++ b/tests/input_files/spring_dashpot_sohex8_prestress_new.dat @@ -66,18 +66,18 @@ E 22 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.25 0.0 FUNCT 1 1 1 E 23 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.2 FUNCT 1 1 1 E 24 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.25 FUNCT 1 1 1 ------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 1.0 0.0 0.0 TIMEFUNCTSTIFF 2 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 3 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 1.0 0.0 TIMEFUNCTSTIFF 0 2 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET 0 2 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 5 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 1.0 TIMEFUNCTSTIFF 0 0 2 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET 0 0 2 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 7 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 9 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 11 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 13 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 3 0 0 DIRECTION xyz COUPLING none -E 15 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET 0 2 0 FUNCTNONLINSTIFF 0 4 0 DIRECTION xyz COUPLING none -E 17 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET 0 0 2 FUNCTNONLINSTIFF 0 0 5 DIRECTION xyz COUPLING none -E 19 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -E 21 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -E 23 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 1.0 0.0 0.0 TIMEFUNCTSTIFF 2 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 3 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 1.0 0.0 TIMEFUNCTSTIFF none 2 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET none 2 0 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 5 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 1.0 TIMEFUNCTSTIFF none 0 2 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET none 0 2 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 7 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 9 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 11 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 13 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 3 0 0 DIRECTION xyz COUPLING none +E 15 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET none 2 0 FUNCTNONLINSTIFF none 4 0 DIRECTION xyz COUPLING none +E 17 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET none 0 2 FUNCTNONLINSTIFF none 0 5 DIRECTION xyz COUPLING none +E 19 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 21 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 23 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -------------------------------------------------------RESULT DESCRIPTION // result tests on cube 1 STRUCTURE DIS structure NODE 1 QUANTITY dispx VALUE 2.01154396429527121e-01 TOLERANCE 1e-9 diff --git a/tests/input_files/spring_dashpot_sohex8_prestress_old.dat b/tests/input_files/spring_dashpot_sohex8_prestress_old.dat index 779c04940e..d44ea0df33 100644 --- a/tests/input_files/spring_dashpot_sohex8_prestress_old.dat +++ b/tests/input_files/spring_dashpot_sohex8_prestress_old.dat @@ -66,18 +66,18 @@ E 22 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.25 0.0 FUNCT 1 1 1 E 23 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.2 FUNCT 1 1 1 E 24 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.25 FUNCT 1 1 1 ------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 1.0 0.0 0.0 TIMEFUNCTSTIFF 2 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 3 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 1.0 0.0 TIMEFUNCTSTIFF 0 2 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET 0 2 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 5 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 1.0 TIMEFUNCTSTIFF 0 0 2 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET 0 0 2 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none -E 7 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 9 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 11 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 13 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 3 0 0 DIRECTION xyz COUPLING none -E 15 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET 0 2 0 FUNCTNONLINSTIFF 0 4 0 DIRECTION xyz COUPLING none -E 17 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET 0 0 2 FUNCTNONLINSTIFF 0 0 5 DIRECTION xyz COUPLING none -E 19 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -E 21 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -E 23 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 1.0 0.0 0.0 TIMEFUNCTSTIFF 2 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 3 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 1.0 0.0 TIMEFUNCTSTIFF none 2 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET none 2 0 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 5 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 1.0 TIMEFUNCTSTIFF none 0 2 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET none 0 2 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none +E 7 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 9 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 11 NUMDOF 1 ONOFF 1 STIFF 1.0 TIMEFUNCTSTIFF 2 VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 13 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 1.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 2 0 0 FUNCTNONLINSTIFF 3 0 0 DIRECTION xyz COUPLING none +E 15 NUMDOF 3 ONOFF 0 1 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 1.0 0.0 TIMEFUNCTDISPLOFFSET none 2 0 FUNCTNONLINSTIFF none 4 0 DIRECTION xyz COUPLING none +E 17 NUMDOF 3 ONOFF 0 0 1 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 1.0 TIMEFUNCTDISPLOFFSET none 0 2 FUNCTNONLINSTIFF none 0 5 DIRECTION xyz COUPLING none +E 19 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 21 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none +E 23 NUMDOF 1 ONOFF 1 STIFF 0.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 1.0 TIMEFUNCTDISPLOFFSET 2 FUNCTNONLINSTIFF 6 DIRECTION refsurfnormal COUPLING none -------------------------------------------------------RESULT DESCRIPTION // result tests on cube 1 STRUCTURE DIS structure NODE 1 QUANTITY dispx VALUE 2.01154396429527121e-01 TOLERANCE 1e-9 diff --git a/tests/input_files/spring_dashpot_sohex8_struct_bc_new_struc.dat b/tests/input_files/spring_dashpot_sohex8_struct_bc_new_struc.dat index c98f18ab1b..99c6cdeefe 100644 --- a/tests/input_files/spring_dashpot_sohex8_struct_bc_new_struc.dat +++ b/tests/input_files/spring_dashpot_sohex8_struct_bc_new_struc.dat @@ -35,7 +35,7 @@ STRUCTURE DIS structure NODE 120 QUANTITY dispx VALUE -6.0e-1 TOLERANCE 1e-14 ----------------------------------------------DESIGN SURF NEUMANN CONDITIONS E 12 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL -1.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 1 1 1 1 1 TYPE Live ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 6 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION cursurfnormal COUPLING 1 +E 6 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION cursurfnormal COUPLING 1 ------------------------DESIGN SURF ROBIN SPRING DASHPOT COUPLING CONDITIONS E 19 COUPLING 1 -----------------------------------------------DESIGN SURF DIRICH CONDITIONS diff --git a/tests/input_files/spring_dashpot_struct_bc.dat b/tests/input_files/spring_dashpot_struct_bc.dat index 0643572da4..518896d545 100644 --- a/tests/input_files/spring_dashpot_struct_bc.dat +++ b/tests/input_files/spring_dashpot_struct_bc.dat @@ -104,18 +104,18 @@ E 10 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 1.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 1 1 1 1 1 TY E 11 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 1.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 1 1 1 1 1 TYPE Live E 12 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 1.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 1 1 1 1 1 TYPE Live -----------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 2 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 3 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 4 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 5 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 6 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 13 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 14 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 15 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 16 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.0 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 17 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF 0 VISCO 0.1 TIMEFUNCTVISCO 0 DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET 0 FUNCTNONLINSTIFF 0 DIRECTION refsurfnormal COUPLING none -E 18 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.05 0.05 0.05 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 1 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 2 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 3 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 4 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 5 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 6 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 13 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 14 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 15 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 16 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.0 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 17 NUMDOF 1 ONOFF 1 STIFF 5.0 TIMEFUNCTSTIFF none VISCO 0.1 TIMEFUNCTVISCO none DISPLOFFSET 0.0 TIMEFUNCTDISPLOFFSET none FUNCTNONLINSTIFF none DIRECTION refsurfnormal COUPLING none +E 18 NUMDOF 3 ONOFF 1 1 1 STIFF 5.0 5.0 5.0 TIMEFUNCTSTIFF none none none VISCO 0.05 0.05 0.05 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -----------------------------------------------DSURF-NODE TOPOLOGY NODE 1 DSURFACE 1 NODE 2 DSURFACE 1 diff --git a/tests/input_files/spring_dashpot_struct_bc_curnormal.dat b/tests/input_files/spring_dashpot_struct_bc_curnormal.dat index d14431b565..57bc623606 100644 --- a/tests/input_files/spring_dashpot_struct_bc_curnormal.dat +++ b/tests/input_files/spring_dashpot_struct_bc_curnormal.dat @@ -46,12 +46,12 @@ E 10 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 1.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 1 1 1 1 1 T E 11 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL 1.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 1 1 1 1 1 TYPE Live E 12 NUMDOF 6 ONOFF 1 0 0 0 0 0 VAL -1.0 0.0 0.0 0.0 0.0 0.0 FUNCT 1 1 1 1 1 1 TYPE Live ---------------------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS -E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 2.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION cursurfnormal COUPLING 1 -E 2 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 2.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION cursurfnormal COUPLING 1 -E 3 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION cursurfnormal COUPLING 1 -E 4 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION cursurfnormal COUPLING 1 -E 5 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION cursurfnormal COUPLING 1 -E 6 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION cursurfnormal COUPLING 1 +E 1 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 2.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION cursurfnormal COUPLING 1 +E 2 NUMDOF 3 ONOFF 1 0 0 STIFF 0.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 2.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION cursurfnormal COUPLING 1 +E 3 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION cursurfnormal COUPLING 1 +E 4 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION cursurfnormal COUPLING 1 +E 5 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION cursurfnormal COUPLING 1 +E 6 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION cursurfnormal COUPLING 1 ------------------------DESIGN SURF ROBIN SPRING DASHPOT COUPLING CONDITIONS E 19 COUPLING 1 -------------------------------------------------------------MORTAR COUPLING diff --git a/tests/input_files/spring_dashpot_struct_nonlinear_bc.dat b/tests/input_files/spring_dashpot_struct_nonlinear_bc.dat index 6ef7c83c3b..3b08a45bde 100644 --- a/tests/input_files/spring_dashpot_struct_nonlinear_bc.dat +++ b/tests/input_files/spring_dashpot_struct_nonlinear_bc.dat @@ -40,7 +40,7 @@ E 1 NUMDOF 3 ONOFF 1 1 1 VAL 0.1 0.0 0.0 FUNCT 1 none none E 1 NUMDOF 3 ONOFF 0 1 1 VAL 0.0 0.0 0.0 FUNCT none none none -----------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS // side_x_free -E 2 NUMDOF 3 ONOFF 1 0 0 STIFF 0 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 2 0 0 DIRECTION xyz COUPLING none +E 2 NUMDOF 3 ONOFF 1 0 0 STIFF 0 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF 2 0 0 DIRECTION xyz COUPLING none -----------------------------------------------DSURF-NODE TOPOLOGY NODE 1 DSURFACE 1 NODE 2 DSURFACE 1 diff --git a/tests/input_files/spring_dashpot_struct_temporal_bc.dat b/tests/input_files/spring_dashpot_struct_temporal_bc.dat index 0073ef1106..8a642afb82 100644 --- a/tests/input_files/spring_dashpot_struct_temporal_bc.dat +++ b/tests/input_files/spring_dashpot_struct_temporal_bc.dat @@ -59,7 +59,7 @@ E 2 NUMDOF 3 ONOFF 0 1 0 VAL 0.0 0.0 0.0 FUNCT none none none E 3 NUMDOF 3 ONOFF 0 0 1 VAL 0.0 0.0 0.0 FUNCT none none none -----------------------DESIGN SURF ROBIN SPRING DASHPOT CONDITIONS // side_free_in_x -E 4 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0e8 0.0 0.0 TIMEFUNCTSTIFF 1 0 0 VISCO 1.0e8 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET -0.1 0.0 0.0 TIMEFUNCTDISPLOFFSET 1 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 4 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0e8 0.0 0.0 TIMEFUNCTSTIFF 1 0 0 VISCO 1.0e8 0.0 0.0 TIMEFUNCTVISCO 2 0 0 DISPLOFFSET -0.1 0.0 0.0 TIMEFUNCTDISPLOFFSET 1 0 0 FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none ----------------------------------------------------------RESULT DESCRIPTION STRUCTURE DIS structure NODE 5 QUANTITY dispx VALUE -1.60441255401115486e-02 TOLERANCE 1e-11 STRUCTURE DIS structure NODE 15 QUANTITY dispx VALUE -1.60441255401118851e-02 TOLERANCE 1e-11 diff --git a/tests/input_files/ssi_oneway_scatra_to_solid_3D_line2_elch_s2i_butlervolmer_multiscale.dat b/tests/input_files/ssi_oneway_scatra_to_solid_3D_line2_elch_s2i_butlervolmer_multiscale.dat index f27874bd31..055de24022 100644 --- a/tests/input_files/ssi_oneway_scatra_to_solid_3D_line2_elch_s2i_butlervolmer_multiscale.dat +++ b/tests/input_files/ssi_oneway_scatra_to_solid_3D_line2_elch_s2i_butlervolmer_multiscale.dat @@ -115,7 +115,7 @@ STRUCTURE DIS structure NODE 8 QUANTITY dispx VALUE -3.07767748348796757e-06 TOL E 1 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.0 FUNCT none none none ----------------------DESIGN POINT ROBIN SPRING DASHPOT CONDITIONS // spring on other side ot the truss -E 2 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0e9 0.0 0.0 TIMEFUNCTSTIFF 0 0 0 VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO 0 0 0 DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET 0 0 0 FUNCTNONLINSTIFF 0 0 0 DIRECTION xyz COUPLING none +E 2 NUMDOF 3 ONOFF 1 0 0 STIFF 5.0e9 0.0 0.0 TIMEFUNCTSTIFF none none none VISCO 0.0 0.0 0.0 TIMEFUNCTVISCO none none none DISPLOFFSET 0.0 0.0 0.0 TIMEFUNCTDISPLOFFSET none none none FUNCTNONLINSTIFF none none none DIRECTION xyz COUPLING none -------------------------------------DESIGN LINE DIRICH CONDITIONS // allow displacement only in x E 4 NUMDOF 3 ONOFF 0 1 1 VAL 0.0 0.0 0.0 FUNCT none none none diff --git a/tests/input_files/volmortar3D_scatra_hex8_tet4_pyr5.dat b/tests/input_files/volmortar3D_scatra_hex8_tet4_pyr5.dat index f419063163..2d579c52e2 100644 --- a/tests/input_files/volmortar3D_scatra_hex8_tet4_pyr5.dat +++ b/tests/input_files/volmortar3D_scatra_hex8_tet4_pyr5.dat @@ -179,15 +179,15 @@ E 17 NUMDOF 3 ONOFF 1 1 1 VAL 0.0 0.0 0.0 FUNCT 0 0 0 E 13 NUMDOF 4 ONOFF 1 1 1 0 VAL 0.0 0.0 0.0 0.0 FUNCT 0 0 0 0 ----------------------------------DESIGN SURF IMPEDANCE CONDITIONS // lumen_outflow_1_all -E 3 ConditionID 1 TYPE windkessel R1 16.9282485746 R2 384.177822039 C 0.000428868124939 TIMEPERIOD 0.1 FUNCT -1 +E 3 ConditionID 1 TYPE windkessel R1 16.9282485746 R2 384.177822039 C 0.000428868124939 TIMEPERIOD 0.1 FUNCT none // lumen_outflow_2_all -E 5 ConditionID 2 TYPE windkessel R1 19.5596235032 R2 426.39437695 C 0.000329276640913 TIMEPERIOD 0.1 FUNCT -1 +E 5 ConditionID 2 TYPE windkessel R1 19.5596235032 R2 426.39437695 C 0.000329276640913 TIMEPERIOD 0.1 FUNCT none // lumen_outflow_3_all -E 7 ConditionID 3 TYPE windkessel R1 11.9963630386 R2 369.635252245 C 0.000481052592584 TIMEPERIOD 0.1 FUNCT -1 +E 7 ConditionID 3 TYPE windkessel R1 11.9963630386 R2 369.635252245 C 0.000481052592584 TIMEPERIOD 0.1 FUNCT none // lumen_outflow_4_all -E 9 ConditionID 4 TYPE windkessel R1 21.4858095071 R2 441.61571679 C 0.000285177090791 TIMEPERIOD 0.1 FUNCT -1 +E 9 ConditionID 4 TYPE windkessel R1 21.4858095071 R2 441.61571679 C 0.000285177090791 TIMEPERIOD 0.1 FUNCT none // lumen_outflow_5_all -E 11 ConditionID 5 TYPE windkessel R1 4.66951602809 R2 69.7349242327 C 0.00215058806096 TIMEPERIOD 0.1 FUNCT -1 +E 11 ConditionID 5 TYPE windkessel R1 4.66951602809 R2 69.7349242327 C 0.00215058806096 TIMEPERIOD 0.1 FUNCT none --------------------------FLUID NEUMANN INFLOW SURF CONDITIONS // lumen_outflow_1_all E 3