[SciPy-Dev] cnemlib scikit

Ralf Gommers ralf.gommers at googlemail.com
Sun Dec 11 11:48:58 EST 2011


On Tue, Dec 6, 2011 at 2:37 PM, illoul lounes <illoul_lounes at yahoo.fr>wrote:

>
> Hi,
>
> We have developed a library (CNEMLIB), which propose an implementation of
> CNEM  in 2d and 3d [1],[2]
> The CNEM is a generalisation for non convex domain of the Natural Element
> Method[3].
>
> The CNEM is a FEM like approach. The main advantages of the CNEM
> comparatively with the FEM, are the following:
>     - nodes and quadrature points are identical,  all the unknowns
> (primal and dual unknowns introduced in Galerkin approaches) are attached
> to the nodes,
>     - due to the usage of Natural Neighbour Shape functions, the CNEM
> doesn't depend on mesh.
>
> The main functionalities of CNEMLIB are:
>     i) interpolation of scattered data spread on convex or non convex
> domains with :
>         - in 2d,  the Natural Neighbour interpolant (Sibson )
>         - in 3d, the Natural Neighbour interpolant (Sibson or Laplace) or
> the linear finite element interpolant over the Delaunay tessellation.
>
>     ii) a gradient matrix operator which allows to calculate nodal
> gradients for scattered data. The approach used is based on the stabilized
> nodal integration SCNI[4].
>     iii) a general assembling tools to construct assembled matrix
> associated with a weak formulation (heat problem, mechanic problem,
> hydrodynamic problem, general purpose problem) as such used with the Finite
> Element Method (FEM).
>
> The functionalities i) and ii) are written in c++ and wrapped for
> python(c++ extension). They are parallelised for 3d applications (shared
> memory using tbb). The assembling tools iii) are in pure python.
>
> The package is license under LGPL. For the 3d applications, we use the
> tetgen library(c++) writen by Hang Si under a MIT licence[5].
>
> You can download the package (source files, setup file for py extension
> build, tutorials)  and the release version for different platforms here :
> http://plateformesn-m2p.ensam.eu/SphinxDoc/cnem/index.html
>
> If you think that the library can be useful for Scipy community, we should
> be very happy to add it in the scikit packages list !
>
>
This looks pretty good. Please add it to this list:
http://scipy.org/Topical_Software

If you'd like to create a scikit from this, I don't see a problem with
that. Either way I'm sure it'll be useful for some people in the SciPy
community.

Cheers,
Ralf
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://mail.python.org/pipermail/scipy-dev/attachments/20111211/0656f99e/attachment.html>


More information about the SciPy-Dev mailing list