Directory > Computers > Programming > Languages > Fortran > Source Code Numerical Methods Fortran 90 codes for a course. http://www.chem.au.dk/~teo/mainmenu/Staff/Stinne/numerical_methods.html Reviews Rating: Not yet Rated
Whois Check
Problem Generators Generators for linear ordering and clustering problems, by John E. Mitchell. http://www.rpi.edu/~mitchj/generators/ Reviews Rating: Not yet Rated
Whois Check
Daniel A. Steck Fortran 90 codes to integrate Ito stochastic differential equations, generate random numbers, compute the FFT, and time programs. http://george.ph.utexas.edu/~dsteck/computer.html Reviews Rating: Not yet Rated
Whois Check
Ernst Mayer Fortran 90 codes for Fast Fourier Transforms and Discrete Weighted Transforms, for use in number theory research. http://hogranch.com/mayer/resume.html Reviews Rating: Not yet Rated
Whois Check
Open-Source Software Codes by Richard Brent for multiple precision arithmetic, uniform and normal random number generators, irreducible/primitive trinomials, and parallel sorting. http://web.comlab.ox.ac.uk/oucl/work/richard.brent/software.html Reviews Rating: Not yet Rated
Whois Check
Introduction to Scientific Computing Fortran and C codes in gzipped tar file from book by Brigitte Lucquin and Olivier Pironneau. http://www.ann.jussieu.fr/soft/calsci.tar.gz Reviews Rating: Not yet Rated
Whois Check
Benchmark 3-D Computational Fluid Dynamics code using the SOR method. There is a link to CPU times on various platforms, for two grid sizes. http://www.ec-nantes.fr/DMN/WWW/Hardware/Bench/index.html Reviews Rating: Not yet Rated
Whois Check
Practical Guide to Splines Code from the book by Carl de Boor. http://www.cs.wisc.edu/~deboor/pgs/ Reviews Rating: Not yet Rated
Whois Check
PDEs and linear equations Fortran and C codes by Dong Liang. http://www.math.yorku.ca/Who/Faculty/dliang/MATH4142/codes.html Reviews Rating: Not yet Rated
Whois Check
Robert Parker Software Plotxy allows the user, either interactively at the terminal, or though scripts, to create simple graphs in the x-y plane. It gives the user complete of control of many aspects of the graph (eg, picture size, text font, line weight, math and Greek symbols, color palette specification). Color produces contour diagrams, with Contour producing a B/W equivalent. Magmap maps magnetic field components using spherical harmonic representations. PSD estimates the Power Spectral Density of a time series. Cross calculates frequency domain functions from a pair of input time series. http://mahi.ucsd.edu/parker/Software/software.html Reviews Rating: Not yet Rated
Whois Check
Single Crystal and Powder Diffraction Many Fortran codes -- search for "fortran" on site. http://www.ccp14.ac.uk/mirror/mirror.htm Reviews Rating: Not yet Rated
Whois Check
Input Routines Fortran 90 module by Andy Stone that parses input lines into 'words', and routines that read a 'word' and translate it into a specified form, usually an integer or double-precision number. In conjunction with a simple CASE structure this provides a powerful and flexible method for organising data input. The package includes documentation, and an example program and data file as illustrations of the ways in which the module can be used to organise data. [gzipped tar file]. http://www-stone.ch.cam.ac.uk/pub/input.tar.gz Reviews Rating: Not yet Rated
Whois Check
Root Rational Fraction (RRF) Program by Anthony Stone and Charles Wood intended primarily for the calculation of Wigner 3j, 6j and 9j symbols, which occur in the theory of angular momentum, and for performing elementary arithmetic with them. http://www-stone.ch.cam.ac.uk/documentation/rrf/rrf.html Reviews Rating: Not yet Rated
Whois Check
OpenMP: Sample Programs Two simple examples of Fortran 77 and 90 programs using the OpenMP API for shared-memory parallel programming. http://www.openmp.org/index.cgi?samples Reviews Rating: Not yet Rated
Whois Check
Lahey's Fortran Code Repository Fortran codes for various tasks. http://www.lahey.com/code.htm Reviews Rating: Not yet Rated
Whois Check
Fortran 90 Software Repository Has short, concise examples of specific features of the Fortran 90, 95 or 2003 language. http://www.nag.com/nagware/examples.asp Reviews Rating: Not yet Rated
Whois Check
Free Software (of Craig C. Douglas) Fortran and C codes for fast matrix multiplication and multigrid solution of PDEs. http://www.ccs.uky.edu/~douglas/ccd-codes.html Reviews Rating: Not yet Rated
Whois Check
Wild-card String Matching Fortran 77 code by Clive Page to do wild-card matching to a pattern, which may contain "?" to match any single character, and "*" to match zero or more consecutive characters of any type. http://www.star.le.ac.uk/~cgp/match_wild.f Reviews Rating: Not yet Rated
Whois Check
Applied Numerical Methods for Scientists and Engineers Fortran and C code from book by Singiresu Rao. http://cwx.prenhall.com/bookbind/pubbooks/rao/chapter0/deluxe.html Reviews Rating: Not yet Rated
Whois Check
Collaborative Computational Projects Links to chemistry, physics, and engineering codes, many in Fortran. http://www.ccp.ac.uk/ Reviews Rating: Not yet Rated
Whois Check
Parallel Sparse Symmetric Direct Solver (PSPASES) High performance, scalable, parallel, MPI-based library, intended for solving linear systems of equations involving sparse symmetric positive definite matrices. The library provides various interfaces to solve the system using four phases of direct method of solution: compute fill-reducing ordering, perform symbolic factorization, compute numerical factorization, and solve triangular systems of equations. http://www-users.cs.umn.edu/~mjoshi/pspases/index.html Reviews Rating: Not yet Rated
Whois Check
OpenMP Tutorial Has examples of Fortran codes using the Message-Passing Interface (MPI). http://www.dartmouth.edu/~rc/classes/intro_mpi/ Reviews Rating: Not yet Rated
Whois Check
Voigt and Complex Error Function By F. Schreier. http://www.op.dlr.de/ne-oe/ir/voigt.html Reviews Rating: Not yet Rated
Whois Check
KindFinder Fortran 90 program by Werner W. Schultz that checks for the available KIND parameters available for a given Fortran 90 or 95 compiler. It prints into a file a new Fortran program that can be compiled to write into a unit the various parameters that describe each integer/real representation. http://www.unics.uni-hannover.de/rrzn/gehrke/kindfind.f90 Reviews Rating: Not yet Rated
Whois Check
Introduction to Molecular Simulation Fortran 77 codes by Rolf Lustig for course. http://academic.csuohio.edu/jgatica/c Reviews Rating: Not yet Rated
Whois Check
Twist: a Compression Utility Compression tool tailored for fields where node-to-node variations are small, and where undefined (dry) nodes are abundant. http://projects.dnmi.no/~telecon/twist/ Reviews Rating: Not yet Rated
Whois Check
Fortran78 Test Suite Product of the NIST Information Technology Laboratory (ITL). It is used to determine, insofar as is practical, the degree to which a Fortran processor conforms to FIPS Fortran. http://www.itl.nist.gov/div897/ctg/fortran_form.htm Reviews Rating: Not yet Rated
Whois Check
Jörgs Useful and Ugly FFT page Code and links in Fortran and C for the Fast Fourier Transform. http://www.jjj.de/fft/fftpage.html Reviews Rating: Not yet Rated
Whois Check
Moisture Content Adjustment Code to predict a property (P2) of dimension lumber at a target moisture content (MC2) given the value of the property (P1) at an initial moisture content (MC1). http://www1.fpl.fs.fed.us/vicki/mcadjust.html Reviews Rating: Not yet Rated
Whois Check
Fast Statistical Methods Fortran 90 and 77 codes by W.H. Press and G.B. Rybicki, for fast inversion matrices of an exponential form arising from autocorrelation functions of Ornstein-Uhlenbeck processes. http://www.lanl.gov/DLDSTP/fast/ Reviews Rating: Not yet Rated
Whois Check
Vadar Structural analysis of protein coordinate data. http://www.pence.ca/software/vadar/latest/vadar.html Reviews Rating: Not yet Rated
Whois Check
Navier-Stokes equation Fortran 90 and 77 codes by Reidar Kristoffersen. http://motor.maskin.ntnu.no/dio1008/ Reviews Rating: Not yet Rated
Whois Check
CFD Recipes Computational fluid dynamics Fortran 77 code associated with "Computational Gasdynamics", a book by Culbert B. Laney. http://capella.colorado.edu/~laney/booksoft.htm Reviews Rating: Not yet Rated
Whois Check
RIM: Computing the Acoutic Field Surrounding a Vibrating Plate Shareware by Stephen Kirkup. http://www.soundsoft.demon.co.uk/rimcode.htm Reviews Rating: Not yet Rated
Whois Check
Texas KZK Time Domain Code Fortran 77 time-domain computer code to model axisymmetric sound beams in fluids. The code is based on an augmented KZK equation that accounts for nonlinearity, diffraction, thermoviscous absorption, and absorption and dispersion due to an arbitrary number of relaxation phenomena. http://people.bu.edu/robinc/kzk/ Reviews Rating: Not yet Rated
Whois Check
Fast Wavelet Transform By Rick Ottolini, based on an article by Gilbert Strang. http://sepwww.stanford.edu/public/docs/sep65/rick2/paper_html/node2.html Reviews Rating: Not yet Rated
Whois Check
Stefan Goedecker's Free Software Fast Fourier Transforms and Silicon interatomic potentials. http://www.unibas.ch/comphys/comphys/SOFTWARE/index.html Reviews Rating: Not yet Rated
Whois Check
CASE Lab Codes Space-time finite element solution for the 1-D Euler equations, STARS orientation angles calculator and elastics vector generator, simulation of a double wedge in a supersonic flow, atmospheric look-up tables, NACA 4-Digit Airfoil, and 2-D aerodynamic loads. http://www.caselab.okstate.edu/codes.html Reviews Rating: Not yet Rated
Whois Check
LFA_Search Fortran 90 code by Chad M. Schafer to numerically approximate the least favorable alternative (LFA) and least regrettable alternative (LRA). These define the minimax expected size and minimax regret confidence procedures, respectively. http://128.32.135.2/users/cschafer/LFA_Search/index.html Reviews Rating: Not yet Rated
Whois Check
Fortran Resources - Garnatz and Grovender Keyed file shareware in Fortran 90 and 77, Fortran 90 interface to the X Window system. http://www.gginc.biz/fort.html Reviews Rating: Not yet Rated
Whois Check
Iounits.f Fortran 77 module to automatically assign i/o unit numbers, by Judah Milgram. http://www.glue.umd.edu/~milgram/iounits.html Reviews Rating: Not yet Rated
Whois Check
ISO Varying String Implemented in the F subset by Rich Townsend. http://www.fortran.com/iso_varying_string.f95 Reviews Rating: Not yet Rated
Whois Check
Dave Gemini Codes for a number-crunching benchmark, reading Internet URL addresses, and partially convertng C code to Fortran. http://home.cfl.rr.com/davegemini/ Reviews Rating: Not yet Rated
Whois Check
Arithmetic with Error Bounds Fortran 90 code by Abraham Agay. http://shum.cc.huji.ac.il/~agay/err.f90 Reviews Rating: Not yet Rated
Whois Check
Hello, World Example of simple program in Fortran. http://www2.latech.edu/~acm/helloworld/fortran.html Reviews Rating: Not yet Rated
Whois Check
Fortran CGI F77 CGI examples using GET and POST. http://www.fcc.gov/mb/audio/bickel/colorit.html Reviews Rating: Not yet Rated
Whois Check
High Performance Fortran Applications Software Catalog Links to fragments, which are very short codes or code fragments to demonstrate the language features and constructs, kernels, which are short self-contained codes chosen as representative of particular application algorithms and their language feature requirements, and full applications codes, not necessarily stored in full locally, but registered here with relevant pointers given to the code owner/contact person. http://www.npac.syr.edu/hpfa/codes.html Reviews Rating: Not yet Rated
Whois Check
G77_i386_fpe_demo Demonstrates handling of floating point exceptions under g77/i386/Linux. By Tom Crane. http://www.mklab.rhul.ac.uk/~tom/g77_i386_fpe_demo/index.html Reviews Rating: Not yet Rated
Whois Check
High Performance Finite Elements Fortran 77 and 90 codes. http://www.featflow.de/ Reviews Rating: Not yet Rated
Whois Check
Simulation of Time-dependent Variable Density Flows Uses a semi-implicit time marching scheme. http://combust1.mech-eng.uiowa.edu/diffusion_flame/dif_flm.html Reviews Rating: Not yet Rated
Whois Check
Algorithms Codes by Julio F. Fernández for uniform and Gaussian random number generation, matrix diagonalization, and physical simulations. http://pipe.unizar.es/~jff/files/files.html Reviews Rating: Not yet Rated
Whois Check
Fortran 77 Codes Programs by John A. Strain to count zeros of the zeta function, compute the Fast Gauss Transform, and use spectral methods to solve nonlinear parabolic systems. http://math.berkeley.edu/~strain/Codes/ Reviews Rating: Not yet Rated
Whois Check
Jeff Cameron's Fortran code Code for the VMS operating system and for a fractal figure called Sierpinski's Gasket. http://www.jcameron.com/vms/fortran.htm Reviews Rating: Not yet Rated
Whois Check
Fundamentals of Numerical Computing Fortran 90 codes from book by Lawrence Shampine, Richard Allen, and Steven Pruess. http://www.mines.edu/fs_home/spruess/saptext/f90code/ Reviews Rating: Not yet Rated
Whois Check
Nick Yas'ko Products Codes for ANSI control sequences, solving linear equations, and creating Poscript graphics. At http://www.uni-koblenz.de/~yasko/BEM/codes.htm there are links to codes for boundary elements and to test Fortran 90 and 95 compilers. http://www.uni-koblenz.de/~yasko/products.htm Reviews Rating: Not yet Rated
Whois Check
Helmholtz Fortran 90 code to solve the Diffusion-Advection-Reaction equation in 2D. http://www.aero.polimi.it/~quartape/bacheca/materiale_didattico/FEM_2D_Dif_Adv_React.f90 Reviews Rating: Not yet Rated
Whois Check
Finite Elements Fortran 90 code by Jacques Laminie. http://www.math.u-psud.fr/~laminie/F90_lib/vers-1.04/ Reviews Rating: Not yet Rated
Whois Check
Ernesto Martin's codes Random generator networks and other algorithms. http://www.mat.uc.pt/~eqvm/cientificos/fortran/codigos.html Reviews Rating: Not yet Rated
Whois Check
TRIMHAP Implements linkage disequilibrium mapping techniques. http://www.vipbg.vcu.edu/trimhap/ Reviews Rating: Not yet Rated
Whois Check
Hompack90 Suite of Fortran 90 subroutines by Layne T. Watson for solving nonlinear systems of equations by homotopy methods. There are subroutines for fixed point, zero finding, and general homotopy curve tracking problems, utilizing both dense and sparse Jacobian matrices, and implementing three different algorithms: ODE-based, normal flow, and augmented Jacobian. http://people.cs.vt.edu/~ltw/hompack90/ Reviews Rating: Not yet Rated
Whois Check
Introduction to F Examples of the F (Fortran 95 subset) language, by Harvey Gould. http://sip.clarku.edu/tutorials/F.html Reviews Rating: Not yet Rated
Whois Check
Numerical Analysis Codes for the book by Richard L. Burden and J. Douglas Faires. http://www.as.ysu.edu/~faires/Numerical-Analysis/DiskMaterial/programs/fortran/ Reviews Rating: Not yet Rated
Whois Check
BIEPACK Code for boundary integral equations, by Kendall E. Atkinson. http://www.math.uiowa.edu/~atkinson/bie.html Reviews Rating: Not yet Rated
Whois Check
Algorithms and Data Structures in F and Fortran Codes from book by Robin Vowels for sorting, linked lists and trees, complex arithmetic, text processing, solving linear equations, graphics, searching, numerical methods, and whole array operations. http://www.fortran.com/F/adsff.html Reviews Rating: Not yet Rated
Whois Check
Benchmarks of N. Tajima Codes to time floating point and integer arithmetic, intrinsic functions, and random access to memory. http://serv.apphy.fukui-u.ac.jp/~tajima/bench/source_e.html Reviews Rating: Not yet Rated
Whois Check
SophtwareKodeWerks Fortran 77 codes to solve the quadratic equation, solve a nonlinear equation using the Newton-Raphson method, fit a simple linear regression, and solve a system of equations using Gaussian elimination. http://www.sophtwarekodewerks.com/fortran.html Reviews Rating: Not yet Rated
Whois Check
Examples Fortran 90 codes from introductory course by John Mahaffy. http://www.personal.psu.edu/faculty/j/h/jhm/f90/progref.html Reviews Rating: Not yet Rated
Whois Check
Gaussm3 Fortran 90 code for Gauss-Legendre and Gaussian quadrature, and solving linear equations by Gauss and Gauss-Jordan elimination, LU and Singular Value Decomposition. http://www.aero.usyd.edu.au/wwwcomp/subrout.html Reviews Rating: Not yet Rated
Whois Check
PsSchur Computes the periodic real Schur decomposition of a matrix product. By Kurt Lust. http://www.cs.kuleuven.ac.be/~kurt/r_psSchur.html Reviews Rating: Not yet Rated
Whois Check
Numerical Methods Code for algebraic and transcendental equations, systems of linear equations, interpolation routines, numerical integration, eigenvalues, and special functions, by Abdusamad Salih. http://www.sali.freeservers.com/engineering/fortran.html Reviews Rating: Not yet Rated
Whois Check
Linear Algebra and Econometrics SPARSEM is a collection of sparse matrix classes that makes programming with sparse matrices (and large problems) almost as easy as a matrix language. BLUPF90 is a BLUP program written using SPARSEM. REMLF90 is a REML version of BLUPF90 that uses accelerated EM algorithm. Other programs included are dense matrix module DENSEOP, Gibbs sampling program GIBBS90, and several versions of linear-threshold models. By Ignacy Misztal and collaborators. http://nce.ads.uga.edu:80/~ignacy/numpub/blupf Reviews Rating: Not yet Rated
Whois Check
Image Estimation by Example Fortran 90 code of Jos Claerbout. http://sepwww.stanford.edu/sep/prof/gee/Lib/ Reviews Rating: Not yet Rated
Whois Check
Wavelet Analysis Code to accompany book by Christopher Torrence and Gilbert P. Compo. http://paos.Colorado.EDU/research/wavelets/ Reviews Rating: Not yet Rated
Whois Check
Numerical Methods and Software Code from book and for nonlinear optimization and matrix equations, by Stephen Nash. http://iris.gmu.edu/~snash/nash/software/software.html Reviews Rating: Not yet Rated
Whois Check
Time Series, Climate Modeling, and other Code By Richard Blender. http://puma.dkrz.de/blender/Softwarering/ Reviews Rating: Not yet Rated
Whois Check
Numerical and Statistical Codes By Jean-Pierre Moreau. http://perso.wanadoo.fr/jean-pierre.moreau/fortran.html Reviews Rating: Not yet Rated
Whois Check
Multivariate Normal Probabilities and Quadratic Assignment Problems Codes by Professor Zvi Drezner. http://business.fullerton.edu/zdrezner/programs.htm Reviews Rating: Not yet Rated
Whois Check
MathFinance - Financial Functions Library Fortran 90 code for the Cox-Ross-Rubinstein binomial model, the analytic Black-Scholes formula, and Monte Carlo Simulation. http://www.mathfinance.de/FF/f90lib.html Reviews Rating: Not yet Rated
Whois Check
Math a la Carte Collections of mathematical software in Fortan and C. Software is free for some uses and can be purchased for others. Much of the software was developed at the Jet Propulsion Laboratory. http://mathalacarte.com Reviews Rating: Not yet Rated
Whois Check
ToyFDTD Finite Difference Time Domain code by L. E. Miller, Paul R. Hayes, and M. O'Keefe. http://www.borg.umn.edu/toyfdtd/ Reviews Rating: Not yet Rated
Whois Check
TLM3D Code by J. L. Herring for transmission line modelling of electromagnetic fields in 3-dimensions using the symmetrical condensed node. http://www.wjrh.ece.uvic.ca/wjrh/tlm/prog-fortran.html Reviews Rating: Not yet Rated
Whois Check
Rule Learning Code estimates the population rule learning model on experimental data. http://www.eco.utexas.edu/Homepages/Graduate/Haruvy/experimental/rlindx.htm Reviews Rating: Not yet Rated
Whois Check
PSIDE (Parallel Software for Implicit Differential Equations) Code for solving implicit differential equations on shared memory parallel computers, by Jacques J.B. de Swart, Walter M. Lioen, and Wolter A. van der Veen. http://www.cwi.nl/archive/projects/PSIDE/ Reviews Rating: Not yet Rated
Whois Check
Prime Counts prime numbers. http://www.math.utah.edu/prime.html Reviews Rating: Not yet Rated
Whois Check
DownGradePrecision Code by Kevin Rhoads to allow precision to be deliberately thrown away in an IEEE floating point compliant computing environment in order to more closely model computations in less precise floating point systems. http://www.fortranlib.com/downprec.txt Reviews Rating: Not yet Rated
Whois Check
Pipelined phase-rotation FFT By David O'Halloran. The Welchel phase-rotation FFT is a new form of the fast Fourier transform (FFT) that replaces data movement at runtime with equivalent multiplications by precomputed constants. The result is an FFT that is easy to pipeline. http://www-2.cs.cmu.edu/afs/cs.cmu.edu/project/iwarp/member/fx/public/www/phase1.html Reviews Rating: Not yet Rated
Whois Check
Fast Hankel Transform By Steve Sheng -- further details can be found in his dissertation. http://www-ee.stanford.edu/~siegman/sheng_fht_package.txt Reviews Rating: Not yet Rated
Whois Check
BETADER Derivatives of the Incomplete Beta Function, by Robert J. Boik and James F. Robison-Cox. http://www.jstatsoft.org/v03/i01/ Reviews Rating: Not yet Rated
Whois Check
ShareBufferWin32 Easy Inter-Process Shared Memory Communication Utilities for Win32 using a simple Fortran 77-style interface. Written for Compaq Visual Fortran by Gary Scott. http://www.fortranlib.com/ShareBufferWin32.f90 Reviews Rating: Not yet Rated
Whois Check
OSCall OS Command line interface utility for Compaq/Intel Visual Fortran with immediate return or wait specified in milliseconds (routine automatically quotes the command string). http://www.fortranlib.com/OSCall.f90 Reviews Rating: Not yet Rated
Whois Check
MPLOT Package of MATLAB-style-callable routines for plain graphics by Valery E.Grikurov, Professor of Mathematics and Mathematical Physics. RGB color scheme is used (TrueColor mode supported). http://mph.phys.spbu.ru/~grikurov/mPlot.f90 Reviews Rating: Not yet Rated
Whois Check
F (Fortran 95 subset) Program Examples Factorial function, iterative computation of the square root, nonadvancing I/O, dynamic arrays, Towers of Hanoi, and other topics. http://www.fortran.com/F/example_code.html Reviews Rating: Not yet Rated
Whois Check
DXFortran: Vectorial graphical library in DXF Develops a vectorial graphical library in DXF (Drawing Interchange Format) format for Fortran 90 programmers. By Carlos Silva and Davide Santos. http://www.ualg.pt/est/adec/csc/dxfortran/ Reviews Rating: Not yet Rated
Whois Check
Fortran Programmers Club Windows 95/98/NT/2000 applications programming in FORTRAN, by Vladimir V. Vasilchenko. Numerous samples of GUIs, using controls and common controls. http://els.donpac.ru/usr/golub/fortran/ Reviews Rating: Not yet Rated
Whois Check
FXDR Library by David W. Pierce that allows calls to the XDR (eXternal Data Representation) routines from Fortran. http://meteora.ucsd.edu/~pierce/fxdr_home_page.html Reviews Rating: Not yet Rated
Whois Check
f90gl Interface for OpenGL and GLUT. By William Mitchell. http://math.nist.gov/~WMitchell/f90gl/ Reviews Rating: Not yet Rated
Whois Check
StopWatch Fortran 90 module, by William Mitchell, for measuring execution time of program segments. It is designed to be a portable, easy-to-use means of measuring execution time. http://math.nist.gov/~WMitchell/StopWatch.html/ Reviews Rating: Not yet Rated
Whois Check
NAS Parallel Benchmarks Set of eight programs designed to help evaluate the performance of parallel supercomputers. The benchmarks, which are derived from computational fluid dynamics (CFD) applications, consist of five kernels and three pseudo-applications. http://www.nas.nasa.gov/Software/NPB/ Reviews Rating: Not yet Rated
Whois Check
Utilities in Fortran 90 Fortran 90 code by Michel Olagnon: pre-processor and pretty-printer, with command-line interface for Unix, fsplit utility for splitting large files into separate ones for each procedure, PostScript converter, interface bloc generator, and format creator for numeric strings. http://www.ifremer.fr/ditigo/molagnon/fortran90/contenu.html Reviews Rating: Not yet Rated
Whois Check
Dan Nagle (Purple Sage Consulting) code Fortran Portability Project, Fortran 2003 examples, and Fortran modules. http://users.erols.com/dnagle/download.html Reviews Rating: Not yet Rated
Whois Check
Fortran Tools by Nelson Beebe Dcl2inc postprocesses ftnchek .dcl files to create separate include files; dtosstod converts Fortran floating-point precision; fpp is a reversible Fortran preprocessor; lprsf3 is a filter to print Fortran and SFTRAN3 files with boldface keywords; and pretty is a Fortran 66 prettyprinter. http://www.math.utah.edu/~beebe/software/fortran-tools.html Reviews Rating: Not yet Rated
Whois Check
GBYTES/SBYTES Library Packages to handle binary unpacking and packing, in Fortran 77 and 90. http://dss.ucar.edu/libraries/gbytes/ Reviews Rating: Not yet Rated
Whois Check
Fast Fourier Transform code By James Van Buskirk. http://home.comcast.net/~kmbtib/index.html Reviews Rating: Not yet Rated
Whois Check
Public Domain Aeronautical Software (PDAS) Programs for aeronautical engineering, many from NASA or USAF, complete with public domain source code, instructions and sample cases on CD-ROM. [Commercial] http://www.pdas.com/ Reviews Rating: Not yet Rated
Whois Check
Computer Methods for Mathematical Computations Code from the book, translated to ELF, a Fortran 90 subset. Algorithms for calculations in science and engineering, including linear equations, spline interpolation, integration, differential equations, zero finding, minimization and singular value decomposition. http://www.pdas.com/fmm.htm Reviews Rating: Not yet Rated
Whois Check
Starlink Astronomy software, much in Fortran. http://star-www.rl.ac.uk/ Reviews Rating: Not yet Rated
Whois Check
Compiler Diagnostic Test Sets Fortran 77/90/95 codes to test run-time diagnostic/debug capability of Windows and Linux Fortran Compilers, by Arnaud Desitter and Herman D. Knoble. http://ftp.aset.psu.edu/pub/ger/fortran/test/results.txt Reviews Rating: Not yet Rated
Whois Check
Memory Leaks Fortran 90 test program by Arjen Markus to see if memory leaks originating from derived-types can be circumvented. http://ftp.aset.psu.edu/pub/ger/fortran/Markus/noleaks.f90 Reviews Rating: Not yet Rated
Whois Check
Alan R. Miller Code from the book "Fortran Programs for Scientists and Engineers", 2nd. ed. (1988). http://www.nmt.edu/~armiller/fortran.htm Reviews Rating: Not yet Rated
Whois Check
Check compiler and run-time environment (CHKSYS) Chksys.f determines the properties of the run-time environment for Fortran 77 programs. Chkcomp.f is a Fortran 77 code containing deliberate deviations from the standard and deliberate bad statements for testing the compiler's accuracy. Chksysff.f90 is a program to determine the properties of the run-time environment for Fortran 90 programs. Chkcomff.f90 is a Fortran 90 source file containing deliberate deviations from the standard and deliberate bad statements for testing the compiler's accuracy. http://ftp.aset.psu.edu/pub/ger/fortran/chksys.htm Reviews Rating: Not yet Rated
Whois Check
Fluid Mechanics NCSE Numerical Methods Library, FDLIB Fluid Dynamics Library, CFDLAB Computational Fluid Dynamics Laboratory, and BEMLIB Boundary-Element Software Library by C. Pozrikidis, Professor of Fluid Mechanics. http://stokes.ucsd.edu/c_pozrikidis/mainpage.html Reviews Rating: Not yet Rated
Whois Check
XML Module by Mart Rentmeester that reads and interprets XML in standard Fortran 95. http://nn-online.sci.kun.nl/fortran/xml/ Reviews Rating: Not yet Rated
Whois Check
XML-Fortran Aims to be a library that allows programmers to access XML files. http://sourceforge.net/projects/xml-fortran/ Reviews Rating: Not yet Rated
Whois Check
Special Functions code Routines to accompany the book "Computation of Special Functions", by Shanjie Zhang and Jianming Jin. http://iris-lee3.ece.uiuc.edu/~jjin/routines/routines.html Reviews Rating: Not yet Rated
Whois Check
Panel Code (Aeronautics) By Professor Kevin D. Jones of the U.S. Naval Postgraduate School. http://www.aa.nps.navy.mil/~jones/online_tools/panel/source/ Reviews Rating: Not yet Rated
Whois Check
ASTEM97 Steam Tables By Edward D. Throm, contains routines to provide a wide range of interfaces to the thermodynamic and transport properties. [Commercial] http://members.cox.net/mister-ed/if97srcc.htm Reviews Rating: Not yet Rated
Whois Check
JPL Planetary and Lunar Ephemerides on CD-ROM by Standish, et. al Contains three different Jet Propulsion Laboratory Planetary and Lunar Ephemerides (DE200, DE405, and DE406) along with associated reading and interpolating routines, allowing the user to obtain the rectangular coordinates of the sun, moon, and nine major planets by means of a subroutine written in standard Fortran. http://www.willbell.com/software/jpl.htm Reviews Rating: Not yet Rated
Whois Check
Numerical Electromagnet Code (NEC) Archives Code in Fortran, C, and Basic. http://www.qsl.net/wb6tpu/swindex.html Reviews Rating: Not yet Rated
Whois Check
PORT Mathematical Subroutine Library Collection of Fortran 77 routines that address many traditional areas of mathematical software, including approximation, ordinary and partial differential equations, linear algebra and eigensystems, optimization, quadrature, root finding, special functions, and Fourier transforms, but excluding statistical calculations. PORT stands for Portable, Outstanding, Reliable, and Tested. http://www.bell-labs.com/project/PORT/ Reviews Rating: Not yet Rated
Whois Check
Introducing Fortran 95 Code from the book by Ian Chivers and Jane Sleightholme. http://www.kcl.ac.uk/kis/support/cit//fortran/f90home.html#2.0 Reviews Rating: Not yet Rated
Whois Check
Peter Benner Fortran 77 code SLICOT Subroutine Library in Control Theory, Parallel Library in Control (PLiC) for large-scale time-invariant linear control systems in state-space form on parallel distributed computers, eigenvalues of Hamiltonian Matrices, subroutines for compressing a symmetric or triangular matrix to packed storage mode or to unpack a packed array to full storage mode, benchmark examples of discrete-time algebraic Riccati equations, benchmark examples of continuous-time algebraic Riccati equations. http://www.math.uni-bremen.de/~benner/software.html Reviews Rating: Not yet Rated
Whois Check
Jugoslav Dujic's Fortran Resources XFT (eXtended Fortran Types) is a set of Fortran modules which wrap some Win32 APIs, the Dialog Management section has an enhanced DFLOGM module from CVF 6 and the Win32 Headers section has translations of some C header files that were not (yet?) incorporated in CVF. http://www.geocities.com/jdujic/fortran/efindex Reviews Rating: Not yet Rated
Whois Check
xmlf90, an XML parser in Fortran90 Written by Alberto Garcia in the F subset of Fortran 95, freely available under the BSD license. http://lcdx00.wm.lc.ehu.es/ag/xml/ Reviews Rating: Not yet Rated
Whois Check
Fortran 90 codes of John Burkardt Translations of Fortran 77 packages Lapack, Linpack, Eispack, Quadpack, and others. Code for graphics, finite elements, random number generation, and other topics. http://www.csit.fsu.edu/~burkardt/f_src/f_src.html Reviews Rating: Not yet Rated
Whois Check
Fortran Bits'n'pieces Fortran sources, including Function Parser, that caches functions (for repetitive calling) and compiles functions to a byte-code representation to speed repeated evaluations. By Stuart Midgley. http://smidgley.customer.netspace.net.au/fortran/ Reviews Rating: Not yet Rated
Whois Check
Roland Schmehl's Fortran parser Another parser of Fortran code. http://www.its.uni-karlsruhe.de/~schmehl/functionparserE.html Reviews Rating: Not yet Rated
Whois Check
Lucent Technologies (Bell Labs.) Non-Exclusive Limited-Use Software An old but dependable library of Fortran 77 code which includes approximation, ODE/PDE solution, linear algebra, optimization, quadrature, root finding, special functions and FFTs. You must agree to single-user licence conditions before downloading a gzipped tar file (1Mb). http://www-out.bell-labs.com/cgi-user/swdist/distribution/ Reviews Rating: Not yet Rated
Whois Check
Jon Ahlquist's date manipulation code Conversion to and from Julian dates, day-of-week and other date calculations, plus historical information. See also datesub.f90 at http://users.bigpond.net.au/amiller/ ftp://ftp.met.fsu.edu/pub/calendar_software Reviews Rating: Not yet Rated
Whois Check
Tomasz Plewa's Numerical methods directory Directory of links to numerical analysis sites, many of which contain software. http://www.labyrinth.net.au/~ctrans/tomasz.html Reviews Rating: Not yet Rated
Whois Check
PNNL Fortran Library (FLIB) Mainly non-numeric library for handling text, including parsing, accessing the command line, dates and times, and some random number generation. http://www.pnl.gov/berc/flib/ Reviews Rating: Not yet Rated
Whois Check
F2KCLI Implements the draft F2K standard for accessing the command line and arguments. Site answers questions and lists supported compilers and platforms. http://www.winteracter.com/f2kcli/ Reviews Rating: Not yet Rated
Whois Check
Alan Genz's homepage Multi-dimensional integration, particularly for statistical applications. http://www.math.wsu.edu/math/faculty/genz/homepage Reviews Rating: Not yet Rated
Whois Check
CHIRP-Z transform for FFTs Little known algorithm for calculating the FFT of a series of any length. Based upon Applied Statistics algorithms 117 & 83. http://users.bigpond.net.au/amiller/apstat/chirp.f90 Reviews Rating: Not yet Rated
Whois Check
Combinatorial algorithms Generation of subsets and permutations, Hamiltonian cycles, determinants and permanents, network flow, and minimum spanning trees. http://www.cs.sunysb.edu/~algorith/implement/wilf/implement.shtml Reviews Rating: Not yet Rated
Whois Check
Orderpack 1.0 sorting and ranking routines in Fortran 90 Public domain package by Michel Olagnon of general and specialized sorting and ranking routines in Fortran 90. Specialized routines include partial sorts, partial ranks, unique sorts, unique ranks, partial and unique sorts, as well as partial and unique ranks. http://www.fortran-2000.com/ Reviews Rating: Not yet Rated
Whois Check
Ooura's Mathematical Software Packages Quadrature, FFT (1D & 2D), Bessel functions, and GAMERF (gamma and error functions, including quadruple precision). http://momonga.t.u-tokyo.ac.jp/~ooura/index.html Reviews Rating: Not yet Rated
Whois Check
Fortran Library Links Gary Scott's extensive collection of source code links. http://www.fortranlib.com/freesoft.htm Reviews Rating: Not yet Rated
Whois Check
Sugihara's Integer-Arithmetic Geometric Software Geometric Software (by Kokichi Sugihara) for Voronoi diagrams in 2D and 3D, and convex hulls in 3D and 4D. http://www.simplex.t.u-tokyo.ac.jp/~sugihara/opensoft/opensofte.html Reviews Rating: Not yet Rated
Whois Check
Automatic Differentiation of Fortran Codes (ADIFOR) Given code as input, it generates code for derivatives including gradients and hessians. http://www-unix.mcs.anl.gov/autodiff/ADIFOR/ Reviews Rating: Not yet Rated
Whois Check
Free Fortran Software A collection of useful links from the Fortran Market. http://www.fortran.com/fortran/free.html Reviews Rating: Not yet Rated
Whois Check
NSWC Library of Mathematics Subroutines NSWC (Naval Surface Warfare Center) Library of Mathematics Subroutines written in Fortran 66. Old but very high quality code. Unfortunately the manual is only available in hard copy, and is very difficult to obtain. The source code is also available by ftp from: ftp://math.jpl.nasa.gov/pub/nswc.93 http://www.uni-koeln.de/themen/mathematik/nswc.html Reviews Rating: Not yet Rated
Whois Check
Fortran Resources (Lahey) A collection of links provided by a vendor of Fortran compilers. http://www.lahey.com/other.htm Reviews Rating: Not yet Rated
Whois Check
Numerical Recipes Home Page Home of the Numerical Recipes series of books on scientific programming, including the Numerical Recipes On-Line Software Store, free upgrades and bug fixes, and the complete books on-line in PostScript and Acrobat formats. The Numerical Recipes code in Fortran 77 and Fortran 90 is not in the public domain. http://www.nr.com/ Reviews Rating: Not yet Rated
Whois Check
Overflow from Alan Miller's Fortran web site Includes updates of some TOMS algorithms, logistic regression, a Fortran 90 version of the special functions from the NSWC (Naval Surface Warfare Center) Math. Library, quadruple precision using 10-byte reals for the NAS Fortran-Plus compiler giving about 38 decimal digit accuracy, and code for Imagine1's F compiler, including the author's least-squares package. F code should compile using any standard Fortran compiler. http://users.bigpond.net.au/amiller/ Reviews Rating: Not yet Rated
Whois Check
Index of /pub/ger/fortran/hdk A useful small collection of snippets of code, some of which is for non-numeric purposes, such as manipulating dates and times. http://ftp.cac.psu.edu/pub/ger/fortran/hdk/ Reviews Rating: Not yet Rated
Whois Check
GAMS : Guide to Available Mathematical Software Guide to mathematical software in Fortran held at a small number of US government establishments. Some sources are in commercial libraries and are not directly accessible. The code is of a uniformly high quality but usually old; there may be more recent and better algorithms available. http://gams.nist.gov/ Reviews Rating: Not yet Rated
Whois Check
|