Ferrite.jl

Finite element toolbox for Julia

OTHER License

Stars
314
Committers
22

Bot releases are visible (Hide)

Ferrite.jl - v0.3.14 Latest Release

Published by github-actions[bot] over 1 year ago

Ferrite v0.3.14

Diff since v0.3.13

Closed issues:

  • Ferrite.nfields should be called differently (#444)
  • Tracking progress for merging the dofhandlers (#629)
  • Dof distribution slow (#632)

Merged pull requests:

  • Pretty printing for MixedDofHandler + L2Projector (#465) (@kimauth)
  • Fix forgotten rebase oopsie (#635) (@termi-official)
  • Update dof storage in MixedDofHandler (#636) (@fredrikekre)
  • Minor performance improvements for close!(::MixedDofHandler) (#637) (@fredrikekre)
  • Don't track internal dofs when distributing dofs for MixedDofHandler (#639) (@fredrikekre)
  • Reduce memory footprint in dof distribution for MixedDofHandler (#642) (@fredrikekre)
  • Use vectors instead of dicts for keeping track of vertex dofs (#643) (@fredrikekre)
  • Add FieldWise and ComponentWise renumbering for mixed grids (#645) (@kimauth)
  • Store field names in MixedDofHandler (#646) (@fredrikekre)
  • Remove getfielddims/getfieldinterpolations/getfieldnames for FieldHandler (#647) (@kimauth)
  • Move create_sparsity_pattern and friends to own file (#649) (@fredrikekre)
  • Implement coupling support for MixedDofHandler (#650) (@fredrikekre)
  • Move shared dofhandler functionality out of DofHandler.jl (#652) (@kimauth)
  • Remove and deprecate nfields (#653) (@termi-official)
  • Create a BitSet of FieldHandler.cellset in loops (#656) (@fredrikekre)
  • remove Ferrite.ndim(dh, fieldname) (#658) (@kimauth)
  • Re-add getfieldnames(::FieldHandler) (#659) (@KnutAM)
  • Use BitSet in apply_analytical! and reshape_to_nodes (#660) (@fredrikekre)
  • Fix various typos (#663) (@goggle)
  • Version 0.3.14 (#665) (@fredrikekre)
Ferrite.jl - v0.3.13

Published by github-actions[bot] over 1 year ago

Ferrite v0.3.13

Diff since v0.3.12

Closed issues:

  • Benchmarking (#94)
  • Don't assume the same number of dofs on egdes/faces (#272)
  • Numerical Evaluation of Order 3,4,5 Lagrange Triangle Inexact (#582)
  • Describe requirements for correct initial conditions (#603)

Merged pull requests:

  • Performance regression tests (#388) (@termi-official)
  • Remove grid representation from MixedDofHandler (#577) (@kimauth)
  • Wedge Support (#581) (@termi-official)
  • Small fixes for topology optimization example (#587) (@blaszm)
  • More development docs related to interpolations (#611) (@termi-official)
  • Fix stokes flow. (#614) (@termi-official)
  • Just a typo in a docstring (#615) (@DRollin)
  • Set up actions/cache for doc builds. (#618) (@fredrikekre)
  • (Performance) improvements on gathering field information from MixedDofHandler (#621) (@kimauth)
  • Making Lagrange2Tri345 interpolation values exact (#633) (@AbdAlazezAhmed)
  • Version 0.3.13 (#634) (@fredrikekre)
Ferrite.jl - v0.3.12

Published by github-actions[bot] over 1 year ago

Ferrite v0.3.12

Diff since v0.3.11

Closed issues:

  • Self-inclusion in topology information incomplete (#453)
  • Topology Bug (#518)
  • Error when adding Dirichlet on nodes for MixedDofHandler (#593)

Merged pull requests:

  • topology fixes and docs clean up (#455) (@koehlerson)
  • Improve cellnodes! (#576) (@kimauth)
  • Fix loading Ferrite + Metis on Julia 1.9 (#588) (@fredrikekre)
  • Minor simplifications and changes to the hyper-elasticity example. (#591) (@fredrikekre)
  • Fix constraint condensation for Symmetric matrices. (#592) (@fredrikekre)
  • Fix dirichlet check cellcheck (#594) (@KnutAM)
  • Add basic Base.show method for assemblers (#598) (@fredrikekre)
  • Fix slow show(grid) (#599) (@KnutAM)
  • Fix coloring for edge case with one or zero cells (#600) (@lijas)
  • Remove incorrect statements about initial conditions (#601) (@KnutAM)
  • fix vtk docs export (#602) (@argeht)
  • DAE initialization note (#604) (@termi-official)
  • Version 0.3.12. (#608) (@fredrikekre)
Ferrite.jl - v0.3.11

Published by github-actions[bot] almost 2 years ago

Ferrite v0.3.11

Diff since v0.3.10

Closed issues:

  • Having to send a time into the function for constraints is a design failure. (#207)
  • Dof distribution methods (#378)
  • Bandwidth/fill-in minimzation algorithms (#393)

Merged pull requests:

  • add!(::ConstraintHandler, ::Dirichlet) for nonconcrete celltypes (#427) (@KnutAM)
  • Implicitly call update!(ch) in close!(ch). (#459) (@fredrikekre)
  • Add doc for option all in add*set! (#527) (@KnutAM)
  • overview of examples / topology optimization example (#531) (@blaszm)
  • Add apply_analytical! function (#532) (@KnutAM)
  • Sparsity patterns without constrained dofs (#539) (@fredrikekre)
  • Rework CellIterator by extracting out the caching part (#546) (@fredrikekre)
  • Metis extension for renumbering. (#549) (@fredrikekre)
  • fix DiscontinuousLagrange value (#553) (@koehlerson)
  • Fixes the discontinuous lagrange reference coords dispatch (#559) (@koehlerson)
  • Add internal function fillzero! for filling stored entries with 0 (#562) (@fredrikekre)
  • Use more efficient sparse matrix constructor when supported (#563) (@fredrikekre)
  • Add package extension for BlockArrays.jl. (#567) (@fredrikekre)
  • Submit coverage from /ext folder. (#568) (@fredrikekre)
  • Make showgrid work for all cells (#570) (@KnutAM)
  • Improvements to local condensation of constraints (#571) (@fredrikekre)
  • Fix a few typos (#574) (@pitmonticone)
  • AffineConstraint for nonzero b and nonlinear problem + docfixes (#575) (@KnutAM)
  • Deprecate push!(dh, ...) in favor of add!(dh, ...) (#578) (@fredrikekre)
  • Fix broken links in docs (#583) (@kimauth)
  • Fix landau.jl (#584) (@KnutAM)
  • Rename MetisExt extension module to FerriteMetis (#585) (@fredrikekre)
  • Preparation for release 0.3.11 (#586) (@fredrikekre)
Ferrite.jl - v0.3.10

Published by github-actions[bot] almost 2 years ago

Ferrite v0.3.10

Diff since v0.3.9

Closed issues:

  • CellIterator not working at all if called without dof handler (#289)
  • inconsistent higher order node between RefCube and RefShape (#520)
  • Affine constraint between two DBC constraints should work (#530)

Merged pull requests:

  • improve performance of apply! be rewriting the part that zero out rows (#489) (@KristofferC)
  • resolve inconsistency between refcube and refshape interpolation in 3D (#523) (@koehlerson)
  • Local condensation of constraints (#528) (@fredrikekre)
  • Unify Dirichlets and affine constraints (#529) (@lijas)
  • Speed-boost for close!(dh::MixedDofHandler) (#533) (@kimauth)
  • Quick fix for threaded assembly example on Julia 1.8 (#534) (@kimauth)
  • Handle prescribed dofs in RHS of affine constraints (#535) (@fredrikekre)
  • Improve get_coordinates! (#536) (@kimauth)
  • Remove some unnecessary allocations in affine constraint condensation (#537) (@fredrikekre)
  • Remove create_sparsity_pattern(::MixedDofHandler) (#538) (@fredrikekre)
  • Unify sparsity pattern creation also when passing the ConstraintHandler. (#540) (@fredrikekre)
  • Skip further lookup work in constraint condensation if current matrix entry is zero. (#541) (@fredrikekre)
  • Support renumbering of ConstraintHandler. (#542) (@fredrikekre)
  • Do not assemble zero contributions from local to global matrix (#543) (@fredrikekre)
  • Specifying coupling between fields/components in create_sparsity_pattern (#544) (@fredrikekre)
  • Implement dof renumbering by fields or components (#545) (@fredrikekre)
  • Remove most uses of at-inbounds in documentation (#547) (@fredrikekre)
  • Refactor _addindex_sparsematrix! into arrayutils.jl (#548) (@fredrikekre)
  • Condense sparsity pattern: don't check if entries already exist (#550) (@fredrikekre)
  • Release 0.3.10. (#551) (@fredrikekre)
Ferrite.jl - v0.3.9

Published by github-actions[bot] about 2 years ago

Ferrite v0.3.9

Diff since v0.3.8

Closed issues:

  • Contributor guideline missing (#391)
  • Change default components to constraint to be all components (#506)

Merged pull requests:

  • grid manual update and new docs for mesh reading (#504) (@koehlerson)
  • Default to constraining all components for (Periodic)Dirichlet. (#509) (@fredrikekre)
  • Update doc build dependencies. (#510) (@fredrikekre)
  • Add CONTRIBUTING.md, fixes #391. (#511) (@fredrikekre)
  • Extend Lagrange elements for 2D Triangles (#512) (@fredrikekre)
  • Extend 2D Gauss Legendre quadrature for triangles up to order 15 (#514) (@edljk)
  • Debug mode toggle (#524) (@termi-official)
  • Release version to 0.3.9. (#525) (@fredrikekre)
Ferrite.jl - v0.3.8

Published by github-actions[bot] about 2 years ago

Ferrite v0.3.8

Diff since v0.3.7

Closed issues:

  • Test failures on Julia master (#492)
  • The bug of "greedy"- algorithm in Threaded Assembly (#502)

Merged pull requests:

  • More efficient way of creating condensed sparsity pattern (#436) (@lijas)
  • Add a logo :) (#464) (@fredrikekre)
  • Fix PointEvalHandler when first point is missing + add some kwargs (#466) (@kimauth)
  • Fix wrong docs: CellIterator, assemble! (#467) (@KnutAM)
  • Throw a more descriptive error message when passing a too long element dof vector. (#469) (@fredrikekre)
  • max(u...) -> maximum(u) in plasticity example (#470) (@KnutAM)
  • Add assemble function for non-square matrices (#471) (@lijas)
  • Remove onboundary from Neumann BC introduction (#473) (@fredrikekre)
  • Fix face node ordering for Tetrahedron{3} (#475) (@fredrikekre)
  • More complete support for periodic boundary conditions (#478) (@fredrikekre)
  • Periodic Nirvana (#481) (@fredrikekre)
  • Assembler: error if number of dofs does not match the size of the local matrix/vector. (#483) (@fredrikekre)
  • Relax type constraints for components in PeriodicDirichlet (#484) (@fredrikekre)
  • remove intermediate vector in ConstraintHandler (#485) (@kimauth)
  • Add notes in doc about mesh parser (#487) (@KnutAM)
  • doc: fix capitalization in postprocessing example (#490) (@fredrikekre)
  • Missing space (#491) (@vinhtu95)
  • fix master test (#493) (@koehlerson)
  • doc: fixed some more typos (#494) (@vinhtu95)
  • Periodic constraints: support dof-rotation (#496) (@fredrikekre)
  • Make FerriteGmsh a proper test dependency. (#499) (@fredrikekre)
  • Update manual section on periodic boundary conditions. (#500) (@fredrikekre)
  • PBC: Change definition of mirror/image mapping (#501) (@fredrikekre)
  • remove unneccessary function parametrization (#503) (@koehlerson)
  • Improvements to grid coloring (#505) (@fredrikekre)
  • Add changelog for 0.3.8, set version to 0.3.8. (#507) (@fredrikekre)
Ferrite.jl - v0.3.7

Published by github-actions[bot] over 2 years ago

Ferrite v0.3.7

Diff since v0.3.6

Merged pull requests:

  • Update the heat equation example (#460) (@fredrikekre)
  • Improvements to hyperelasticity example (#461) (@fredrikekre)
  • Fix tests for WriteVTK 1.14.3 which uses 64-bit integers in the output. (#462) (@fredrikekre)
Ferrite.jl - v0.3.6

Published by github-actions[bot] over 2 years ago

Ferrite v0.3.6

Diff since v0.3.5

Merged pull requests:

  • Fix bug with L2projection of mixed grid (#456) (@lijas)
  • Expand manual section on Dirichlet constraints. (#458) (@fredrikekre)
Ferrite.jl - v0.3.5

Published by github-actions[bot] over 2 years ago

Ferrite v0.3.5

Diff since v0.3.4

Closed issues:

  • apply_rhs! doesn't work with affine constraints (#419)
  • MixedDofHandler: Pushing mixed fields on a per field bases doesn't work (#429)
  • project_to_nodes = true with quadratic elements. (#440)

Merged pull requests:

  • Topology information in grid (#363) (@koehlerson)
  • DofHandler with any <: AbstractGrid (#379) (@koehlerson)
  • Update FEM Introduction Page (#408) (@termi-official)
  • Update docs for affine constraints (#423) (@lijas)
  • start docs for MixedDofHandler (#426) (@kimauth)
  • PointEval: Mention NaNs in output for points that were not found. (#430) (@fredrikekre)
  • AffineConstraints: Fix usage with get_rhs_data. (#431) (@fredrikekre)
  • Error when pushing fields to cells which already are in MixedDofHandler (#432) (@kimauth)
  • Delete an unused pirate-ish method of iterate(::Vector). (#437) (@fredrikekre)
  • Use EnumX.at-enumx for scoping enums. (#438) (@fredrikekre)
  • Polish hyperelasticity examples (#439) (@termi-official)
  • allow node renumbering during vtk export (#441) (@kimauth)
  • Rename internal curl to curl_from_gradient (#442) (@KnutAM)
  • Remove the copy!! function and use copy! from Base (#443) (@KnutAM)
  • Kam/assemble docs (#447) (@KnutAM)
  • Apply (Cell|Face)Values docstring to (Cell|Face)(Scalar|Vector)Values too. (#450) (@fredrikekre)
  • Set version to 0.3.5. (#452) (@fredrikekre)
Ferrite.jl - v0.3.4

Published by github-actions[bot] over 2 years ago

Ferrite v0.3.4

Diff since v0.3.3

Closed issues:

  • Linear constraints (#400)
  • FerriteMeshParser (#424)

Merged pull requests:

  • Linear constraints (#401) (@lijas)
  • Adding docstrings while learning Ferrite (#414) (@KnutAM)
  • Remove export of ScalarValues and VectorValues (#416) (@KnutAM)
  • Small optimimization of constraint condensation (#417) (@fredrikekre)
  • Periodic Dirichlet boundary conditions (#418) (@fredrikekre)
  • Use built-in sparse matrix plotting instead of UnicodePlots. (#421) (@fredrikekre)
  • Various fixes to documentation. (#422) (@fredrikekre)
  • Arbitrary evaluation in points (#425) (@fredrikekre)
  • Store interpolations and quadrature rules in FEValues. (#428) (@fredrikekre)
Ferrite.jl - v0.3.3

Published by github-actions[bot] over 2 years ago

Ferrite v0.3.3

Diff since v0.3.2

Merged pull requests:

  • Check quadrature point index before using at-inbounds. (#407) (@fredrikekre)
  • Remove some unnecessary at-pure from function/gradient evaluation. (#409) (@fredrikekre)
  • Fix some todos in assembly docs. (#410) (@fredrikekre)
  • FaceValues boundscheck on reinit! (#411) (@kimauth)
  • Add copy(u) to not modify internal DiffEq state. (#412) (@fredrikekre)
  • Add documentation for apply(_zero)!. (#413) (@fredrikekre)
  • Move applyzero check out of loop in apply. (#415) (@fredrikekre)
Ferrite.jl - v0.3.2

Published by github-actions[bot] almost 3 years ago

Ferrite v0.3.2

Diff since v0.3.1

Closed issues:

  • Implementing Discontinuous Lagrange Interpolations (#352)

Merged pull requests:

  • More Grid Docs, mostly related to API Reference (#306) (@koehlerson)
  • Drop support for Julia 1.0. (#385) (@fredrikekre)
  • Support matrix input for L2 projection. (#386) (@fredrikekre)
  • Implement export of projected fields using the projector (#390) (@fredrikekre)
  • Some common elements (#392) (@termi-official)
  • WorkStream coloring algorithm (#396) (@fredrikekre)
  • Allow coloring subsets of cells (#402) (@kimauth)
  • Better warning for empty sets (#403) (@lijas)
  • WIP: Traits for ScalarValues / VectorValues (#404) (@kimauth)
  • Fixed Helmholtz example - Neumann Boundary Condition (#405) (@blaszm)
  • Export tensors with component names. (#406) (@fredrikekre)
Ferrite.jl - v0.3.1

Published by github-actions[bot] about 3 years ago

Ferrite v0.3.1

Diff since v0.3.0

Closed issues:

  • How to set up CompatHelper in a package that depends on JuAFEM.jl? (#310)
  • Subparametric elements with MixedDofHandler and ConstraintHandler does not work: (#315)
  • Any plans to register this package? (#319)
  • Hyperelasticity demo (#321)
  • "Optimized" function_divergence is slow (#336)
  • JuliaPDE survey update? (#349)
  • Use StableRNG for reliable tests? (#351)
  • MixedDofHandler doesn't distribute dofs correctly when all fields live on subdomains (#358)
  • Mixed Derivatives with Tensors (#364)
  • Dof ordering for multi-field dof handlers (#365)
  • OutOfMemory excepiton (#367)

Merged pull requests:

  • some small optimization tweaks (#337) (@KristofferC)
  • change function_divergence for a more well-performing option (#338) (@KristofferC)
  • bugfixes for findfirst in MixedDofHandler+ tests (#340) (@kimauth)
  • continue CI even if nightly fails (#342) (@KristofferC)
  • Allow boundary condition on edges/vertices (#343) (@lijas)
  • Update README.md (#344) (@lijas)
  • correct function_gradient docstring (#345) (@kimauth)
  • support adding Dirichlet BCs to nodesets (#346) (@kimauth)
  • remove unused field_idx computation (#347) (@kimauth)
  • fix ch when adding bcs to faces with MixedDofHandler (#348) (@kimauth)
  • use StableRNGs for testing the sha of the exported files (#350) (@KristofferC)
  • Quadratic Serendipity Hex Interpolation (#353) (@koehlerson)
  • refactor vtk_point_data(vtkfile, dh, u) for access to its reordering outside of vtk export (#354) (@kimauth)
  • add regression test for subparametric elements for MixedDofHandler (#356) (@koehlerson)
  • Add Contributing and Questions section to README (#357) (@kimauth)
  • Fixes 358 (#359) (@JimBrouzoulis)
  • add CITATION.cff (#362) (@koehlerson)
  • Remove unused type arguments that cause allocations in Ferrite.cellnodes!() (#366) (@lijas)
  • Simple Example for DifferentialEquations integration (#368) (@termi-official)
  • Add an example illustrating implementation of nearly incompressible hyperelasticity (#370) (@bhaveshshrimali)
  • Reduce the ouput in quasi-incompressible hyperelasticity example (#373) (@bhaveshshrimali)
  • Update plasticity example to use immutable structs for material states. (#376) (@fredrikekre)
  • add feature: point evaluation (#377) (@kimauth)
  • L2Projector bugfix + test (#381) (@kimauth)
  • doc: set old states to new in plasticity example. (#382) (@fredrikekre)
  • Fix vtk export of 2nd order tensors + vtk export docs (#383) (@kimauth)
  • Set version to 0.3.1, add missing compat, update doc deps. (#384) (@fredrikekre)
Ferrite.jl - v0.3.0

Published by github-actions[bot] over 3 years ago

Ferrite v0.3.0

Closed issues:

  • Try becoming API compatible with the common stuff in CALFEM (#1)
  • Provide methods for reading .mat files exported from matlab (#2)
  • Warn if det(J) <= 0 (#16)
  • Dev docs (#20)
  • Move plotting from Winston.jl to Plots.jl (#34)
  • Petition to remove the first row in EDOF (#37)
  • Separate CALFEM stuff into its own repo (#53)
  • Change Square + Triangle -> Cube and Tetraheder (#57)
  • Function spaces and quadrature rules are created differently. (#61)
  • Computing things on faces of elements (#66)
  • QuadratureRule creation (#74)
  • Documentation (#75)
  • Naming of functions (#78)
  • Distinction between geometric interpolation space and function interpolation space (#79)
  • Extend FECellValues to return vector valued shape functions (#86)
  • Change FEBoundaryValues (#87)
  • Code duplications (#90)
  • Update docs (#92)
  • Useful grid functionality (#102)
  • Use NBInclude to test notebooks (#105)
  • Run doc build in testscript (#114)
  • Compilation time of generating a quadrature rule is very long (#128)
  • Stuff to fix (#131)
  • Is this an ok place to ask questions? Not sure if there is a gitter channel (#147)
  • Assemble matrix when functions have explicit x-dependence (#150)
  • DofHandler does't account for higher order basis functions (#153)
  • missing create_face_quad_rule (#164)
  • Better way to add a facesets (#165)
  • Support adding boundary conditions on specific nodes (#166)
  • Unused exports: CellFace and FaceIterator (#172)
  • colon error in steprange (#184)
  • Bug in addcellset! (#189)
  • Caching the set of faces that each boundary node is part of (#199)
  • Plasticity example (#206)
  • Make all notebooks into Literate.jl examples. (#208)
  • generate_grid(Tetrahedron) results in bad grid (#210)
  • heat_equation.jl example confusing markdown and julia comments? (#214)
  • Include JuAFEM in a package via REQUIRE (#221)
  • Jacobian Determinant Abs (#223)
  • Have a version comatible with Julia 0.6? (#224)
  • zeroing out the sparse values in start_assemble might not be a good idea (#237)
  • ERROR: LoadError: UndefVarError: assemble not defined (#250)
  • Export vector fields in 3D (#259)
  • reinit!(cellvalues, cell) only works for certain degrees (#265)
  • Minisymposium at JuliaCon ? (#273)
  • New name (#274)
  • apply! without modifying A (#280)
  • Helmholtz equation results (#288)
  • Allow kwargs for overloaded JuAFEM vtk_grid constructor (#293)

Merged pull requests:

  • Min första pull request! (#3) (@JimBrouzoulis)
  • Utilities (#4) (@JimBrouzoulis)
  • Små uppdateringar till solveq och patch test (#5) (@KristofferC)
  • extrahera förskjutningar + ett exempel (#6) (@JimBrouzoulis)
  • La till en liten stång (#7) (@JimBrouzoulis)
  • Lägga till eldraw (#8) (@KristofferC)
  • improve performance of plani4e (#9) (@KristofferC)
  • add linear triangle element (#10) (@KristofferC)
  • liberate the functions! (#11) (@KristofferC)
  • Utilities (#12) (@JimBrouzoulis)
  • Fixa plot (#13) (@KristofferC)
  • WIP: Add methods for generating elements (#14) (@KristofferC)
  • remove winston from ci (#15) (@KristofferC)
  • add static condensation (#17) (@KristofferC)
  • Update documentation system (#18) (@KristofferC)
  • add nonlinear 2d bar (#19) (@KristofferC)
  • remove Requires dep (#21) (@KristofferC)
  • add coordxtr (#22) (@KristofferC)
  • add "s" versions of functions (#23) (@KristofferC)
  • add f versions (#24) (@KristofferC)
  • add topologyxtr (#25) (@KristofferC)
  • WIP: VTK support (#26) (@KristofferC)
  • improve perf coordxtracts (#27) (@KristofferC)
  • transpose ALL the things (#28) (@KristofferC)
  • improve perf in inv by doing it inplace (#29) (@KristofferC)
  • fix to not assemble transpose (#30) (@KristofferC)
  • transposing (#31) (@fredrikekre)
  • refactor into moving things to the type system (#32) (@KristofferC)
  • fix bug and add tests for derivative (#33) (@KristofferC)
  • improve performance of assembler (#35) (@KristofferC)
  • add quadratic triangle lagrange function space (#36) (@KristofferC)
  • edof change (#38) (@KristofferC)
  • added fe_values (#39) (@KristofferC)
  • Added support for 1d with FEValues and function spaces (#40) (@fredrikekre)
  • Added support for 1d with FEValues and function spaces (#41) (@KristofferC)
  • add getters for function space and quadrule, also fix arugment order (#42) (@KristofferC)
  • fix so JuAFEM works on julia 0.5 (#43) (@KristofferC)
  • change to BaseTestNext (#44) (@KristofferC)
  • WIP: started on function interpolations (#45) (@KristofferC)
  • fix some docs (#46) (@KristofferC)
  • move the non mutating functions to the abstract type (#47) (@KristofferC)
  • parameterize quadrature rule on dim (#48) (@KristofferC)
  • make function space parameterized on dim (#49) (@KristofferC)
  • Faster version of vtk_grid (#50) (@fredrikekre)
  • Use ContMechTensors whith JuAFEM (#51) (@KristofferC)
  • WIP: remove calfem stuff (#54) (@KristofferC)
  • fix bugs in node order and add tests (#55) (@KristofferC)
  • add function space and gauss rule for tetraheder (#56) (@KristofferC)
  • clean up quadrature creation (#58) (@KristofferC)
  • remove coordxtr and topologyxtr (#59) (@KristofferC)
  • rename shapes (#60) (@KristofferC)
  • test assemble (#62) (@KristofferC)
  • change quadrature construction (again) (#63) (@KristofferC)
  • Update documentation system (#64) (@KristofferC)
  • Fix for new conversion in ContMechTensors (#67) (@fredrikekre)
  • Updates for Documenter.jl syntax changes (#68) (@MichaelHatherly)
  • symbol => Symbol... (#69) (@fredrikekre)
  • New version of vtk_grid (#70) (@fredrikekre)
  • Separate geometric interpolation space from function interpolation space (#71) (@fredrikekre)
  • check if detJdV > 0 (#72) (@fredrikekre)
  • Introducing FEBoundaryValues (#73) (@fredrikekre)
  • Remake QuadratureRule (#76) (@fredrikekre)
  • Spatial coordinate (#77) (@fredrikekre)
  • Renaming functions (#80) (@fredrikekre)
  • Move deprecated function (#81) (@fredrikekre)
  • Add VTK_type for all function space (#82) (@fredrikekre)
  • Remove loop in assemble (#83) (@fredrikekre)
  • Grid class (#84) (@fredrikekre)
  • make getters uniform (#85) (@fredrikekre)
  • add FEVectorCellValues (#88) (@KristofferC)
  • make stuff compact (#89) (@KristofferC)
  • make cell boundary a keyword (#93) (@KristofferC)
  • fix deprecation in test (#95) (@fredrikekre)
  • remove test files (#96) (@fredrikekre)
  • add BoundaryVectorValues (#97) (@fredrikekre)
  • Change order of the tetrahedron nodes (#98) (@fredrikekre)
  • coord fix (#99) (@fredrikekre)
  • [WIP] Update documentation (#101) (@fredrikekre)
  • doctest update (#104) (@fredrikekre)
  • test notebooks (#106) (@KristofferC)
  • FunctionSpace -> Interpolation (#107) (@fredrikekre)
  • Cherries from #100 (#108) (@fredrikekre)
  • grid generator fix (#109) (@fredrikekre)
  • add some mesh functions (#110) (@KristofferC)
  • relax matrix in assembler (#111) (@fredrikekre)
  • make assember for residual (#112) (@fredrikekre)
  • use > rather than <=, check before inverting (#113) (@fredrikekre)
  • [RFC] Better way too loop over grid cells (#115) (@fredrikekre)
  • build docs in testscript, run in stric mode (#116) (@fredrikekre)
  • [WIP] Add support for evaluating vector functions with vector of node values (#117) (@fredrikekre)
  • Relax to abstractvector (#118) (@fredrikekre)
  • swap to Tensors.jl (#119) (@KristofferC)
  • Relax function_symmetric_gradient (#120) (@fredrikekre)
  • rework celliterator (#121) (@fredrikekre)
  • Julia v0.6 fix (#123) (@fredrikekre)
  • inbounds assembling (#124) (@fredrikekre)
  • Lots of stuff... (#125) (@KristofferC)
  • quadratic tetrahedron interpolation (#129) (@fredrikekre)
  • store boundaries in a matrix (#130) (@KristofferC)
  • reset residual (#132) (@fredrikekre)
  • misc updates (#133) (@fredrikekre)
  • wip symmetric assembly (#134) (@fredrikekre)
  • use AD to compute shape derivatives (#135) (@KristofferC)
  • use GaussQuadrature instead of FastGaussQuadrature (#136) (@KristofferC)
  • Notebook cleanup (#137) (@fredrikekre)
  • always add diagonal elements (#139) (@fredrikekre)
  • use Tensors.jl AD instead (#141) (@fredrikekre)
  • fix meandiag (#142) (@KristofferC)
  • Add UpdateFlags (#143) (@fredrikekre)
  • link to the example notebooks from the docs (#144) (@fredrikekre)
  • [WIP] API consistency review (#145) (@fredrikekre)
  • define copy for FEValues (#148) (@fredrikekre)
  • drop julia v0.5 support (#149) (@fredrikekre)
  • export cellid (#151) (@fredrikekre)
  • initialize fevalues with NaN's to catch missing reinit! (#154) (@fredrikekre)
  • bugfix for different geometric interpolation (#155) (@fredrikekre)
  • remove requires (#156) (@KristofferC)
  • Fix deprecations (#157) (@femtocleaner[bot])
  • remove unused code (#158) (@fredrikekre)
  • new dofhandler (#159) (@fredrikekre)
  • Correct typo (#161) (@mohamed82008)
  • improve perf for apply! (#163) (@KristofferC)
  • fix export of vector field (#168) (@fredrikekre)
  • some cleanup, no functional change (#169) (@fredrikekre)
  • fix (#173) (@fredrikekre)
  • addfaceset! (#174) (@fredrikekre)
  • Test and fix cook notebook, some perf improvements (#175) (@KristofferC)
  • rm new line in Grid and DirichletBoundaryConditions show methods (#176) (@fredrikekre)
  • generate example from .jl file (#177) (@fredrikekre)
  • [WIP] documentation overhaul (#178) (@fredrikekre)
  • rename DirichletBoundaryConditions to ConstraintHandler (#179) (@fredrikekre)
  • rename DirichletBoundaryCondition to Dirichlet (#180) (@fredrikekre)
  • clean up testfiles (#183) (@fredrikekre)
  • colon of steprange vs ternary op fix (#185) (@louisponet)
  • wip add dof range to compute range for a field (#187) (@KristofferC)
  • updated docgen (#188) (@fredrikekre)
  • Fix issue 189 (#190) (@mohamed82008)
  • implement coloring function and add an example of threaded assembling (#196) (@KristofferC)
  • Make an example of cooks membrane (#197) (@fredrikekre)
  • no longer use ForwardDiff (#198) (@KristofferC)
  • semi-build stage for docs (#201) (@fredrikekre)
  • simple renumber (#202) (@fredrikekre)
  • re-activate indent removal for Literate.markdown (#203) (@fredrikekre)
  • Fix default_interpolation of QuadraticTetrahedron (#204) (@mohamed82008)
  • add Literate as test/REQUIRE and go back to default test script (#205) (@fredrikekre)
  • update for Literate v0.2 (#209) (@fredrikekre)
  • Fix tetrahedron grid generator (#211) (@haampie)
  • Linear time and memory addition of node dbcs (#215) (@mohamed82008)
  • implement function_curl and shape_curl (#220) (@fredrikekre)
  • fixes for julia 0.7 (#222) (@fredrikekre)
  • Add a note on Julia compatibility and installation in the README (#225) (@fredrikekre)
  • More 0.7 fixes. (#226) (@fredrikekre)
  • Use projects for documentation and code coverage (#227) (@fredrikekre)
  • Landau (#229) (@louisponet)
  • Some stuff (#230) (@fredrikekre)
  • Fix deprecated setindexing in apply_zero!. (#231) (@fredrikekre)
  • remove boundscheck on f when inbounds assembling (#233) (@KristofferC)
  • Misc updates (#234) (@fredrikekre)
  • allow abstract vectors as arguments to Dirichlet (#235) (@KristofferC)
  • Update doc-build deps and test on Julia 1.1. (#238) (@fredrikekre)
  • Overload show(io, mime, x) instead of show(io, x) for pretty-printing. (#239) (@fredrikekre)
  • Export all cellsets by default in vtk_cellset (#240) (@fredrikekre)
  • Upgrade documentation build dependencies (#241) (@fredrikekre)
  • Allow AbstractVector in apply!. (#242) (@fredrikekre)
  • Added an example implementation of a von Mises plasticity model. (#243) (@JimBrouzoulis)
  • Delete heat_square.ipynb (#245) (@KristofferC)
  • Support for mixed celltypes (#246) (@JimBrouzoulis)
  • Remove ugly joinpath calls, fix version in Project.toml. (#248) (@fredrikekre)
  • Implement fillzero kwarg to start_assemble, fix #237. (#251) (@fredrikekre)
  • move some figures from toplevel example to doc example (#252) (@KristofferC)
  • Fix hyperelasticity example (#253) (@KristofferC)
  • Upgrade Literate and Documenter. (#254) (@fredrikekre)
  • Run CI on 1.2 and build docs on Julia 1.2. (#255) (@fredrikekre)
  • Make a Literate.jl example with hyperelasticity. (#256) (@fredrikekre)
  • Move generated to examples in order to get nicer URLs (#257) (@fredrikekre)
  • fixup some doc issues (#258) (@KristofferC)
  • Pad with zeroes for dim = 2 when exporting vector field, fixes #259. (#260) (@fredrikekre)
  • add helmholtz example to the docs (#261) (@jw3126)
  • Update doc build deps and build docs from GH Actions. (#262) (@fredrikekre)
  • update Literate version (#263) (@KristofferC)
  • correct helmholtz example math (#264) (@jw3126)
  • fix #265 (#266) (@jw3126)
  • Mixed grid updates (#268) (@JimBrouzoulis)
  • Adds support for making a L2-projection of values (#271) (@JimBrouzoulis)
  • Add missing image, misc doc-building updates. (#275) (@fredrikekre)
  • add an extra quad rule for tetrahedrons (#276) (@KristofferC)
  • Changes to MixedDofHandler (#279) (@lijas)
  • fix error in CellIterator when using MixedDofhandler (#282) (@lijas)
  • fix celliterator again... (#284) (@lijas)
  • Fix CellIterator constructor (#285) (@kimauth)
  • Set 0 as default value for export to avoid leaving NaN's. (#286) (@fredrikekre)
  • Fix CellIterator for mixed meshes (#292) (@kimauth)
  • Make it possible to distribute dofs for shells and beams/bars in 2d/3d (#296) (@lijas)
  • WriteVTK: pass through compress keyword argument, fixes #293. (#297) (@fredrikekre)
  • add dof_range function for MixedDofHandler (#299) (@kimauth)
  • update L2 projection (#300) (@kimauth)
  • Misc fixes for CellIterator without DofHandler (#301) (@fredrikekre)
  • Small changes to L2projector (#303) (@lijas)
  • apply_rhs! with rhsdata (#304) (@koehlerson)
  • Basic Grid Docs (#305) (@koehlerson)
  • Make MixedDofHandler take any grid (#309) (@lijas)
  • MixedDofHandler checks (#320) (@kimauth)
  • Bugfixes for bidomain DifferentialEquations.jl example (#322) (@koehlerson)
  • Examples/bidomain differentialequationsjl (#323) (@koehlerson)
  • Examples/bidomain differentialequationsjl (#324) (@koehlerson)
  • move to new org (#327) (@KristofferC)
  • rename JuAFEM to Ferrite (#328) (@KristofferC)
  • remove examples that have moved to docs, and move the example folder (#329) (@KristofferC)
  • Improvements to L2 projection (#331) (@fredrikekre)
  • bugfix on CellIterator with given cellset (#332) (@kimauth)
  • Misc CI updates and update to doc build deps (#333) (@fredrikekre)
  • doc: add some more fluff to L2 projection example. (#334) (@fredrikekre)
Ferrite.jl - 0.4 working version

Published by KristofferC about 8 years ago