Releases: KratosMultiphysics/Kratos
Releases · KratosMultiphysics/Kratos
v10.0
What's Changed
- [OptApp] by @talhah-ansari in #12304
- [GeoMechanicsApplication] Incremental displacement variable, output and integration test. by @WPK4FEM in #12288
- [GeoMechanicsApplication] Add 1D functionality to the existing 2D/3D thermal element by @mnabideltares in #12303
- [CoSim] Changing CMAKE to C++17 in CoSIm External Lib by @Igarizza in #12209
- [README] Update README in master by @loumalouomega in #12316
- [Core] Fix Average Element size calculator for 2D9N by @sunethwarna in #12301
- [GeoMechanicsApplication] Add 1D functionality to existing 2D/3D Pw element by @mnabideltares in #12292
- Release 9.5 by @roigcarlo in #12314
- [Poro] Initialisation of stresses by @xaviertort in #12330
- Optimizing HROM Setup Performance by @SADPR in #12270
- [Gitignore] Adding IDX to the Gitignore file by @loumalouomega in #12332
- [Release] Missing meta for pytho n3.12 by @roigcarlo in #12333
- [GeoMechanicsApplication] Extract computation of integration coefficients by @avdg81 in #12334
- [GeoMechanicsApplication] Fix standard k0 procedure for C++ workflow by @rfaasse in #12321
- [RomApp] Testing (with) RomManager by @Rbravo555 in #12285
- [StructuralMechanicsApplication] semi-rigid hinge at 3d2n linear beam by @aronnoordam in #12290
- [OptApp] SIMP control for Topology Optimization by @sunethwarna in #12328
- [OptApp] Clean material controls by @sunethwarna in #12329
- [RomApp] Skipping LSPG B&S cpp test by @Rbravo555 in #12339
- [Mapping] Implementing == and != operators by @roigcarlo in #12317
- [GeoMechanicsApplication] Clean up and extract calculation of deformation gradients by @avdg81 in #12341
- [FastPR][Hotfix][Fluid] Navier-Stokes wall condition DOF position hotfix by @rubenzorrilla in #12335
- [GeoMechanicsApplication] Simplified fluid flux for pw element by @rfaasse in #12338
- [GeoMechanicsApplication] Extract B matrix calculations by @rfaasse in #12337
- Fix Memory Leak in LSPG ROM Builder and Solver by Ensuring Vector Zeroing by @SADPR in #12342
- [GeoMechanicsApplication] Add cross-sectional area to the thermal line element by @mnabideltares in #12349
- [RomApp] Adding training routine for neural networks to be used in ANN-PROM by @NicolasSR in #11988
- [Core][TrilinosApplication] Defining list of fastest direct linear solvers. by @loumalouomega in #12350
- [GeoMechanicsApplication] Fixed the bug related to shape-function-gradients for thermal line el… by @mnabideltares in #12347
- [GeoMechanicsApplication] Fixed a bug where the maximum number of iterations was not properly read by @avdg81 in #12354
- [GeoMechanicsApplication] Add cross-sectional area to the Pw line element by @mnabideltares in #12358
- Making the for_each catch definition consistent with KRATOS_NO_TRY_CATCH by @roigcarlo in #12362
- [GeoMechanicsApplication] Add point heat flux (source) condition for heat by @mnabideltares in #12340
- [Core] Fix condition creation in sub model part by @ddiezrod in #12364
- [GeoMechanicsApplication] Fix bug in calculation of shape-function-gradients in Pw line element by @mnabideltares in #12357
- [GeoMechanicsApplication] Extract a static utility function for the calculation of the Mass Matrix (M) by @markelov208 in #12299
- [GeoMechanicsApplication] Reduce use of ElementVariables in element strain vector calculations by @rfaasse in #12361
- [SIApp] Add a SI Unit test by @sunethwarna in #12298
- [GeoMechanicsApplication] Formatted custom_utilities using clang format by @rfaasse in #12367
- [Core] Minor clean up
GeometricalProjectionUtilities
by @loumalouomega in #12365 - [Core] Improve performance in
GenerateEntitiesFromConnectivities
by @loumalouomega in #12348 - [GeoMechanicsApplication] Removing commented code and changing typedef -> using by @rfaasse in #12369
- [GeoMechanicsApplication] Extract a static utility function for the calculation of the Damping Matrix (D) by @markelov208 in #12368
- [GeoMechanicsApplication] Clean up / simplify the calculation of the permeability update factor by @avdg81 in #12372
- [Core] Clean up test
Triangle3D3
, updateProjectPointLocalCoordinates
definition by @loumalouomega in #11051 - [GeoMechanicsApplication] Extract pre-calculated lists for strain vectors and (determinants of) deformation gradients by @rfaasse in #12363
- [GeoMechanicsApplication] Added a missing
#include
in a unit test file by @avdg81 in #12377 - [CLApp] Adding secant to plasticity and minor bugsolves by @AlejandroCornejo in #12287
- [GeoMechanicsApplication] Inlined member functions
SetRetentionParameters
by @avdg81 in #12374 - [GeoMechanicsApplication] Removed all unused math utilities by @avdg81 in #12383
- [GeoMechanicsApplication] Add point flux (source) condition for Pw by @mnabideltares in #12376
- [geoMechanicsApplication] extract CalculateFluidPressure function by @markelov208 in #12381
- [GeoMechanicsApplication] Removed a redundant
override
by @avdg81 in #12384 - [Core] Add Voxel Mesh Generation Modeler by @jcotela in #12297
- [GeoMechanicsApplication] Extract list for constitutive matrices and stress vectors by @rfaasse in #12380
- Add missing KRATOS_API by @jcotela in #12387
- [GeoMechanicsApplication] Implement well constitutive behaviour for line thermal element by @mnabideltares in #12370
- [GeoMechanicsApplication] Calculate strains by @markelov208 in #12385
- [GeoMechanicsApplication] extract SetConstitutiveParameters function by @markelov208 in #12382
- [GeoMechanicsApplication] extract stiffness matrix utility by @markelov208 in #12388
- [GeoMechanicsApplication] Removed three empty statements by @avdg81 in #12390
- [Poro] Add new post-processing variables by @xaviertort in #12393
- [GeoMechanicsApplication] Clean up retention response by @avdg81 in #12392
- [Doc] Update cite links + adding activity/star activity by @loumalouomega in #12395
- [Core] Adding a method to fetch the non-converged solutions from the NewtonRaphson strategy by @Rbravo555 in #12375
- [Doc][MappingApplication] Documentation for the 3D/2D metamapper by @loumalouomega in #12391
- [GeoMechanicsApplication] Extract biot coefficient calculation by @rfaasse in #12398
- geo/Fixed missing include transport equation utilities by @WPK4FEM in #12403
- [Core] Fix Python stub generation by @sunethwarna in #12404
- [Fluid] Div-stable P2P1 element by @rubenzorrilla in #12331
- [Core] Remove Incorrect Members from PointerHashMapSet by @matekelemen in #11602
- [GeoMechanicsApplication] Extract a static u...
Release v9.5
What's Changed
- [GeoMechanicsApplication] Moved logic of
ApplyScalarConstraintsTableProcess
to C++ by @avdg81 in #11669 - [GeoMechanicsApplication] Send logging output of Settlement workflow to logging delegate by @carloslubbers in #11671
- [GeoMechanicsApplication] Geo/11626 initialize solving strategies settlement by @rfaasse in #11665
- [GeoMechanicsApplication] Renamed a few files and classes as suggested by @carloslubbers by @avdg81 in #11674
- Geo/umat parameters python by @EleniSmyrniou in #11476
- [GeoMechanicsApplication] Moved logic of ApplyExcavationProcess to C++ by @indigocoral in #11680
- [MEDApp] some fixes in tests by @philbucher in #11683
- [GeoMechanicsApplication] Geo/time step loop by @WPK4FEM in #11677
- [Core] Transition changes geometrical object bins, add
PointIsInsideBoundingBox
functionality by @loumalouomega in #11678 - [Core] Clean up
mesh.h
file by @loumalouomega in #11686 - [Core] AMGCL NS - Allow using different var for pressure by @ddiezrod in #11687
- [MedApp] more geom types and other minor improvements by @philbucher in #11684
- [GeoMechanicsApplication] Fixed the model part used by the process creators for settlement by @avdg81 in #11692
- Adding geo to releases by @roigcarlo in #11694
- [Core] Extend
CppTestsUtilities
withCreateCubeSkinModelPart
andCreateCubeModelPart
by @loumalouomega in #11697 - [GeoMechanicsApplication] Added reading missing parameters for the solving strategy by @rfaasse in #11693
- Extend porous navier stokes by @jgonzalezusua in #11236
- [Core] Mixed Generic Criterion - fixing error when dofs and input variables mismatch by @ddiezrod in #11688
- Kratos lspg hrom by @SADPR in #11569
- [FastPR][ConvDiff] Enhance element substitution by @rubenzorrilla in #11695
- [FluidBio][Bugfix] OSI-related indicators bugfix by @rubenzorrilla in #11698
- [GeoMechanicsApplication] Phreatic multi line by @mcgicjn2 in #11184
- [Med] minor cleanup in tests by @philbucher in #11700
- [GeoMechanicsApplication] Added the missing keyword
raise
by @avdg81 in #11706 - [MedApp] add ImportMedModeler by @philbucher in #11685
- [StructuralMechanicsApplication] bugfix jumping moving load by @aronnoordam in #11699
- [Core] add intel compiler to message by @philbucher in #11709
- [Hotfix][Core] Project serialization fix by @rubenzorrilla in #11705
- [Docker] only new intel compiler by @philbucher in #11715
- [MedApplication] Add support for reading SubModelParts by @philbucher in #11605
- [GeoMechanicsApplication] Move normal load logic to cpp by @markelov208 in #11711
- [Core][Documentation] Even more documentation for
pointer_vector_set.h
by @loumalouomega in #11664 - [MedApp] add python registry by @philbucher in #11708
- [Core][MPI] Partially adapt
CppTestsUtilities
for MPI by @loumalouomega in #11716 - [OptApp] Integration of NLOPT library by @RezaNajian in #11480
- [GeoMechanicsApplycation] Settlement API by @rfaasse in #11701
- Adding Inlet/Outlet warning message for twofluid hydraulic solver by @uxuech in #11652
- [Core] Separate
PointObject
in different file by @loumalouomega in #11725 - Add vtk Biquadratic element by @jginternational in #11704
- [Core] Adding deprecation message to CheckSameModelPartUsingSkinDistanceProcess + check dimension by @loumalouomega in #10715
- Geo/11721 fix settlement output by @rfaasse in #11728
- [Core] Defines
ObjectType
andPointType
inGeometricalObjectsBins
by @loumalouomega in #11731 - Geo/tests strain measures by @WPK4FEM in #11696
- [Core] Adding minor definition for
ObjectType
forPointObject
by @loumalouomega in #11735 - [Core] Defining
GetBoundingBox
inTree
class. Plus adding documentation by @loumalouomega in #11730 - [GeoMechanicsApplication] Define, add, and register variables for thermal analysis by @avdg81 in #11736
- [Core] Adding
GetObjectType
and defineObjectType
inTree
by @loumalouomega in #11737 - [Core] Specialize
PointObject
forGeometry<Node>
by @loumalouomega in #11738 - [GeoMechanicsApplication] Enable line load in settlement workflow by @carloslubbers in #11723
- [MPM] Cleanup set and fill buffer size by @ncrescenzio in #11650
- [GeoMechanicsApplication] Fixed a bug and removed some duplicated code by @avdg81 in #11750
- Update README.md by @mcgicjn2 in #11755
- [OptApp] Fixing tolerance issue in the test by @sunethwarna in #11760
- [Core] Add
SetRank
method toGlobalPointer
+ documentation by @loumalouomega in #11762 - [Core] Defining distance in
SearchInRadius
inGeometricalObjectBins
by @loumalouomega in #11754 - [Core] Moving
GetObjectType
intree.h
by @loumalouomega in #11739 - [GeoMechanicsApplication] Fixed a bug related to handling of conditions by @avdg81 in #11765
- [MPM] Moving
print_output_process
outsideprocesses
by @ncrescenzio in #11768 - [Core] Define and use
PointLocalCoordinatesTetrahedra3D4N
inTetrahedra3D10
when planar face by @loumalouomega in #11767 - [Core] Fixed a warning reported by CMake by @avdg81 in #11773
- [GeoMechanicsApplication] Add thermal constitutive law by @markelov208 in #11747
- [Core] Release 9.4.3 by @roigcarlo in #11752
- [Core] Defining bounding box and
ObjectType
inDynamicBins
by @loumalouomega in #11741 - [Core][MPI] Adding
MinLocAll
andMaxLocAll
toDataCommunicator
by @loumalouomega in #11712 - [Core] Unify SearchUtilities by @loumalouomega in #11710
- Update license.txt by @mcgicjn2 in #11756
- [GeoMechanics ]Correting GeoMechanics Wheel dependencies by @roigcarlo in #11758
- [Core] std::result_of => std::invoke_result by @matekelemen in #11749
- [Core] Missing colon in check_same_model_part_using_skin_process.py by @qiukailu in #11778
- [MPM] Boundary particle distribution and improvements for Penalty imposition by @VeronikaSinger in #10071
- [GeoMechanicsApplication] Updated multiple moving load tests to work and to run by @mcgicjn2 in #11722
- mStrainSize and mSpaceDimension by nature are positive integer types by @WPK4FEM in #11784
- [GeoMechanicsApplication] Removing unused element geometry in RetentionLaw::Parameters by @rfaasse in #11787
- [ContactStructural/Core] Fixing point object by @roigcarlo in #11751
- [Core] Remove deprecated warning by @loumalouomega in #11777
- [Core] Add mising methods ...
Release 9.4.2
Highlight
- Fixed modeler problems
What's Changed
- [Core][GeomContainer] Allow existing geometries by @philbucher in #11641
- [Core][Model] remove flatmap by @philbucher in #11653
- [Core] Document
pointer_vector_set.h
by @loumalouomega in #11655 - [Fluid] Weakly-compressible automatic differentiation enhancements by @rubenzorrilla in #11646
- [Core][HDF5] Fixing HDF5App tests in win by @roigcarlo in #11657
- [ConvDiff] ConvectionDiffusionApplication testing utilities by @rubenzorrilla in #11659
- Geo/add time step executor by @WPK4FEM in #11649
- [Core][MPI] Minor fix in STL IO in MPI write by @loumalouomega in #11656
- [Core][Documentation] Adding documentation to
DataValueContainer
by @loumalouomega in #11661 - [ConvDiff] Axisymmetric convection-diffusion element and thermal face by @rubenzorrilla in #11660
- [GeoMechanicsApplication] Add support for non-uniform line loads by @avdg81 in #11658
- [GeoMechanicsApplication] Add a time incrementor that models a collection of prescribed time increments by @avdg81 in #11662
- [GeoMechanicsApplication] Isolated Hencky strain computation, such that it appears once. by @WPK4FEM in #11667
- [Pip] Adding missing modules for packaging by @roigcarlo in #11668
- Release 9.4.1 by @roigcarlo in #11654
- [Free Surface] Solve problem with assignment of material properties by @joaquinirazabal in #11670
Full Changelog: v9.4.1...v9.4.2
Release 9.4.1
What's Changed
- [Fem2Dem] More cleaning by @AlejandroCornejo in #11497
- [HDF5] Update - 1 - Refactor HDF5File by @sunethwarna in #11473
- [GeoMechanicsApplication] Some more cleanup in
custom_constitutive
by @avdg81 in #11499 - [CLApp] Implementing fatigue data container by @atfard in #11494
- [CLApplication] Missing includes by @loumalouomega in #11500
- [Core] Better debugging at
entities_utilities
in debug mode by @loumalouomega in #11502 - Optapp/ Adding QNBB line search technique by @Igarizza in #11431
- [Core] Refactor
set_identity_function.h
by @loumalouomega in #11408 - [Core] Adding hash for
std::pair
by @loumalouomega in #11312 - [FEM2DEM] minor mistake in ptype by @AlejandroCornejo in #11501
- [External] Update
Clipper2
library by @loumalouomega in #11504 - [ContactStructuralMechanicsApplication] Minor optimization in
mesh_tying_mortar_condition.cpp
by @loumalouomega in #11508 - [Poro] Add new joint constitutive laws to python by @joaquinirazabal in #11514
- [Doc] Update win min version by @roigcarlo in #11515
- [CoSimulationApplication] Adding
AcuSolve
wrapper by @loumalouomega in #11512 - [GeoMechanicsApplication] More code smells resolved on custom_constitutive by @WPK4FEM in #11516
- Minor femdem corrections by @AlejandroCornejo in #11525
- [CoSimulationApplication] Minor refactor and typo correction in documentation and solver wrapper by @loumalouomega in #11524
- [Testing] Split Checks by @roigcarlo in #11526
- Thermally coupled Constitutive Laws by @AlejandroCornejo in #9053
- [ConstitutiveLawsApplication] Fix macros tests after recent merge by @loumalouomega in #11530
- [Doc] Update INSTALL.md with Msys UCRT64 (new standard) by @loumalouomega in #11496
- [FastPR][Core] Adding HasPrototypeEntity to EntityIdentifier by @rubenzorrilla in #11533
- [Core] Minor clean up source files. Refactor
code_location.cpp
,communicator.cpp
, andbounding_volume_tree.cpp
by @loumalouomega in #11519 - [Core] Controllers - Add Output Controller by @sunethwarna in #11509
- [Core] Fix stub generation for core sub modules by @sunethwarna in #11539
- [FastPR][Core] Geometries PrintData minor improvement by @rubenzorrilla in #11446
- [Core] Fix python name exposure by @sunethwarna in #11538
- [Core] make remove installation directories optional by @jrubiogonzalez in #11540
- [GeoMechanicsAnalysis] added test for changing waterlevel by @indigocoral in #11517
- [DAMApplication] Fix Python Wheel by @roigcarlo in #11541
- Optapp/restructuring 23 gradient projection by @Igarizza in #11225
- [GeoMechanicsApplication] Addressed a number of code smells by @mnabideltares in #11544
- [GeoMechanicsApplication] Addressed several recently introduced code smells by @avdg81 in #11546
- [Core] Adding clearing of processes to
Clear
inAnalysisStage
by @loumalouomega in #11547 - [FastPR][Fluid] Upgrade README.md by @rubenzorrilla in #11549
- Bump actions/checkout@v3 to @v4 by @roigcarlo in #11552
- [StructuralMechanicsApplication] Calculate disp and rot at moving load by @aronnoordam in #11537
- [Core][MPI] Reorganize testing utilities by @roigcarlo in #11553
- Kratos Master-Slave Constraints to Neighbours Process and Utility by @SADPR in #11129
- [Core] Expose to python
IsActive
fromGeometricalObject
andMasterSlaveConstraint
by @loumalouomega in #11554 - [GeoMechanicsApplication] Added a process factory to be used by custom workflows (in C++) by @avdg81 in #11555
- Kratos LSPG update. by @SADPR in #11545
- [OptimizationApp] Marking test a expected failure until fixed by @roigcarlo in #11557
- [GeoMechanicsApplication] Improved reading of input files from settlement workflow by @avdg81 in #11562
- [Core] Remove unused process by @loumalouomega in #11543
- [Core] Adding missing checks to
test_dofs
and document it by @loumalouomega in #11568 - [CLApp] Clean and bug solve in Viscous CLs by @AlejandroCornejo in #11570
- [GeoMechanicsApplication] dgeosettlement refactoring for testability by @rfaasse in #11567
- [Core][MPI] Update test suite for DistributedVectorExporter by @loumalouomega in #11173
- [Core] Change Registry GetValue by @roigcarlo in #11574
- [Core] Expose
HasMasterSlaveConstraint
fromModelPart
to python by @loumalouomega in #11582 - [CompressiblePotentialFlowApp] Adding Line Search Strategy to settings by @Marco1410 in #11575
- [Core] Some python binding clean up (I) by @loumalouomega in #11584
- [Core] Some python binding clean up (II) by @loumalouomega in #11585
- MedApplication by @philbucher in #11419
- [CI][Docker] remove unused versions of MMG by @philbucher in #11587
- [RomApp] Adding candidate elements (and/or conditions) to HROM by @Rbravo555 in #11577
- Adding a new two fluid solver for hydraulic application by @uxuech in #11025
- [Core] Some python binding clean up (III) by @loumalouomega in #11586
- [Core] clean filesystem inlcudes by @philbucher in #11489
- [MEDApp] Minor Fixes by @matekelemen in #11580
- [DEMApplication] Fixed some bugs and added a smooth-joint model by @ChengshunShang1996 in #11323
- [Core] Extend IntegrationUtilities to Compute Derivatives by @sunethwarna in #11604
- install med in docker by @philbucher in #11603
- [Core] Minor CMake typo fix by @loumalouomega in #11607
- Second shape derivatives transform implementation by @jgonzalezusua in #11253
- [GeoMechanicsApplication] Add process factory to settlement workflow by @rfaasse in #11591
- [PFEMFluid] Add controller to GiDOutput by @rubenzorrilla in #11614
- [Hotfix][Core] Quad element size fix by @rubenzorrilla in #11571
- Update navier_stokes_compressible_explicit_solver.py - rebuild_level value by @Marco1410 in #11618
- [TrilinosApplication] Fix typo in
trilinos_linear_solver_factory.cpp
by @loumalouomega in #11623 - [RomApp] Fixing bug in ECM by @Rbravo555 in #11611
- [RomApp] BugFix RomManager on a multiparametric simulation by @Rbravo555 in #11612
- Correct AssignMasterSlaveConstraintsToNeighboursProcess and Remove Trailing Spaces by @SADPR in #11629
- [Core] Fix Matrix from Sliced Array by @matekelemen in #11627
- [CoSim] update CoSimIO to v 4.3 by @philbucher in #11550
- [Core] Remove deprecated "new_line...
Release 9.4
v9.4 Test Laplacian Element
Release 9.3
- Added Python 3.11 support
- Added new Kratos registry.
- HDF5Application is now available for python
- New LSPG solver for ROM
You can get the last version of Kratos from pip:
$ pip install KratosMultiphysics-all
Or this version:
$ pip install KratosMultiphysics-all==9.3
Release 9.2
Kratos now uses C++17 by default.
You can get the last version of Kratos from pip:
$ pip install KratosMultiphysics-all
Or this version:
$ pip install KratosMultiphysics-all==9.2
Release 9.1.4
Added developments for the Eflows4HPC European Project.
You can get the last version of Kratos from pip:
$ pip install KratosMultiphysics-all
Or this version:
$ pip install KratosMultiphysics-all==9.1.4
Release 9.1
- Added distributed sparse matrices
- Fixed module errors in CoSimulationApplication
- Added initial background support for multistage
To obtain the code please:
pip install KratosMultiphysics-all
Kratos Multiphysics 9.0
Features
-
Distribution:
- Kratos is now distributed and installed through python packages. Please refer to the wiki for more info.
- Kratos now supports being installed with popular python modules (numpy, scipy etc...)
-
Features:
-
Core:
- ParallelUtilities can now handle exceptions in parallel regions
- Linear and Quadratic pyramid geometries are added
-
CoSimulationApplication:
- Support for coupling to external solvers in MPI through CoSimIO
- In MPI is is now possible to have solvers run with less MPI processes or in serial
-
MappingApplication:
- Support for mapping non-historical variables was added
- Searching was improved and is much faster now
-
MultilevelMonteCarloApplication
- Hierarchical Monte Carlo methods support MPI parallelism
-
ExaquteSandboxApplication
- Added initial condition process (it supports MPI parallelism)
- Added wind generator process to generate steady-state and turbulent wind inlet (it supports MPI parallelism)
- Added process to compute simultaneously drag force and base moment
-