Skip to content

johannesgerer/jburkardt-py

Folders and files

NameName
Last commit message
Last commit date

Latest commit

 

History

4 Commits
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 

Repository files navigation

Python Source


  • args, a script which reports the command line arguments with which it was invoked;
  • ball_grid, a library which computes grid points inside a 3D ball.
  • bellman_ford, a library which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
  • bvec, a library which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
  • c4lib, a library which implements certain elementary functions for single precision complex (C4) variables;
  • c8lib, a library which implements certain elementary functions for double precision complex (C8) variables;
  • cauchy_principal_value, a library which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
  • circle_arc_grid, a program which computes grid points along a circular arc.
  • cube_grid, a library which computes a grid of points over the interior of a cube in 3D.
  • cycle_brent, a library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.
  • cycle_floyd, a library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.
  • disk_grid, a library which computes grid points within the interior of a disk of user specified radius and center in 2D, using matplotlib to create an image of the grid.
  • dolfin, scripts which are used with the DOLFIN library to set up and solve a wide variety of problems using the finite element method.
  • dolfin-convert, a program which can convert mesh file from Gmsh, MEDIT, METIS or SCOTCH format to an XML format suitable for use by DOLFIN or FENICS, by Anders Logg.
  • ellipse_grid, a library which computes grid points over the interior of an ellipse in 2D.
  • ellipsoid_grid, a library which computes a grid of points over the interior of an ellipsoid in 3D.
  • fd1d_advection_lax_wendroff, a program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to approximate the time derivative, creating a graphics file with matplotlib.
  • fd1d_heat_explicit, a library which implements a finite difference method (FDM), explicit in time, to solve the time dependent 1D heat equation;
  • fd1d_heat_implicit, a program which implements a finite difference method (FDM), implicit in time, to solve the time dependent 1D heat equation;
  • fem_to_xml, reads a pair of FEM files defining node coordinates and elements, of a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding XML file for input to DOLFIN or FENICS.
  • fem1d, a program which applies the finite element method (FEM) to a boundary value problem (BVP) in one spatial dimension, using a procedural approach.
  • fem1d_bvp_linear, a program which applies the finite element method (FEM), with piecewise linear elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  • fem1d_bvp_quadratic, a program which applies the finite element method (FEM), with piecewise quadratic elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  • fem1d_classes, a library which defines classes useful for solving a boundary value problem (BVP) of the form u''+2u'+u=f in 1 spatial dimension, using the finite element method (FEM), by Mike Sussman.
  • fem2d_bvp_linear, a program which applies the finite element method (FEM), with piecewise bilinear elements, to a 2D boundary value problem (BVP) in a rectangle.
  • fem1d_heat_explicit, a program which uses the finite element method (FEM) and explicit time stepping to solve the time dependent heat equation in 1D.
  • filum, a library which performs various operations on files;
  • four_fifths, a library which searches for a solution to the problem of finding four fifth powers that sum to a fifth power, that is, integers a, b, c, d and e such that a^5+b^5+c^5+d^5=e^5. Euler conjectured that no solution was possible. The code is by Brian Hayes.
  • freefem++_msh_io, a library which can read and write files used by the FreeFem++ finite element program to store mesh information.
  • hello, a script which prints "Hello, world!".
  • hello_mpi, a script which prints out "Hello, world!", carried out in parallel using MPI and MPI4PY.
  • hypercube_grid, a library which computes a grid of points over the interior of a hypercube in M dimensions.
  • i4lib, a library which contains many utility routines, using single precision integer (I4) arithmetic.
  • kronrod, a library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
  • latin_random, a library which computes Latin Random Squares of N points in M dimensions;
  • legendre_product_polynomial, a library which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
  • line_grid, a library which computes a grid of points over the interior of a line segment in 1D.
  • machine, a library which returns tabulated values of the constants associated with computer arithmetic;
  • md, a program which carries out a molecular dynamics simulation, and is intended as a starting point for implementing a parallel version.
  • monomial, a library which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or in a given range.
  • monomial_value, a library which evaluates a monomial in M dimensions.
  • navier_stokes_2d_exact, a library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations over an arbitrary domain in 2D.
  • navier_stokes_3d_exact, a library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations over an arbitrary domain in 3D.
  • normal, a library which implements a random number generator (RNG) for normally distributed values;
  • polpak, a library which evaluates a variety of mathematical functions, including Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre, Legendre polynomials, and the Collatz sequence.
  • polygon_grid, a library which generates a grid of points over the interior of a polygon in 2D.
  • polynomial, a library which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
  • prime_mpi, a script which counts the number of primes between 1 and N, carried out in parallel using MPI and MPI4PY.
  • prime_serial, a script which counts the number of primes between 1 and N, and is intended as a starting point for a parallel version.
  • py, a directory of example Python scripts.
  • pyramid_grid, a library which computes a grid of points over the interior of the unit pyramid in 3D;
  • quad_mpi, a script which approximates an integral using a quadrature rule, carried out in parallel using MPI and MPI4PY.
  • quad_serial, a script which applies a quadrature rule to estimate an integral, intended as a starting point for parallelization exercises.
  • quadrule, a library which implements rules for approximate integration (quadrature) in one dimension;
  • r4lib, a library which contains many utility routines, using single precision real (R4) arithmetic.
  • r8lib, a library which contains many utility routines, using double precision real (R8) arithmetic.
  • rkf45, a script which implements the Runge-Kutta-Fehlberg (RKF) solver for the approximate solution of an ordinary differential equation (ODE) system.
  • rnglib, a library which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.
  • search_mpi, a script which searches integers between A and B for a solution J such that F(J)=C, carried out in parallel using MPI and MPI4PY.
  • search_serial, a script which searches integers between A and B for a solution J such that F(J)=C, intended as a starting point for parallelization exercises.
  • simplex_grid, a library which generates a regular grid of points over the interior of an arbitrary simplex in M dimensions.
  • snakes_and_ladders, a library which simulates the game of Snakes and Ladders, and estimates the average number of moves in a one-player game.
  • sobol, a library which computes elements of a Sobol quasirandom sequence.
  • sort_rc, a library which can sort a list of any kind of objects, using reverse communication (RC).
  • sparse_grid, some classes and functions defining sparse grids.
  • sphere_fibonacci_grid, a library which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.
  • sphere_llq_grid, a library which uses longitudes and latitudes to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.
  • sphere_llt_grid, a library which uses longitudes and latitudes to create grids of points, lines, and triangles on the surface of the unit sphere in 3D.
  • spiral_data, a library which computes a velocity vector field that satisfies the continuity equation, writing the data to a file that can be plotted by gnuplot.
  • square_grid, a library which computes a grid of points over the interior of a square in 2D.
  • stokes_2d_exact, a library which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
  • subset, a library which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems.
  • table_io, functions which read and write files (not very much here yet.)
  • test_mat, a library which defines test matrices for which some of the determinant, eigenvalues, inverse, null vectors, P*L*U factorization or linear system solution are already known, including the Vandermonde and Wathen matrix.
  • test_values, a library which returns selected values of some special functions;
  • tetrahedron_grid, a library which computes a grid of points over the interior of a tetrahedron in 3D.
  • timer, a library which implements various real time and CPU time tests.
  • timestamp, a script which prints the current YMDHMS date as a timestamp.
  • triangle_grid, a library which computes a grid of points over the interior of a triangle in 2D.
  • triangle_integrals, a library which returns the exact value of the integral of any polynomial over the interior of an arbitrary triangle in 2D.
  • triangle01_integrals, a library which returns the integral of any monomial over the interior of the unit triangle in 2D.
  • truncated_normal, a library which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
  • truncated_normal_rule, a program which computes a quadrature rule for a normal probability density function (PDF), sometimes called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].
  • uniform, a library which contains uniform random number generators (RNG's) for several arithmetic types.
  • wathen, a library which compares storage schemes (full, banded, sparse triplet, sparse) and solution strategies (A\x, Linpack, conjugate gradient) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).
  • wedge_grid, a library which computes a grid of points over the interior of the unit wedge in 3D.
  • wtime, a library which shows how to return a reading of the wall clock time.
  • xml_to_fem, a script which reads an XML file created by FENICS or DOLFIN, describing a mesh in 1D, 2D, or 3D, and extracts two sets of information, namely, the coordinates of nodes, and the indices of nodes that form each element, which constitute an FEM model of the mesh.

You can go up one level to the main web page.


Last revised on 18 May 2015.

About

Git Mirror of John Burkardt's great collection of Python Software

Resources

License

Stars

Watchers

Forks

Releases

No releases published

Packages

No packages published

Languages