Ecosyste.ms: Awesome
An open API service indexing awesome lists of open source software.
Fortran
Fortran is a statically typed compiled programming language that is especially suited to numeric computation, and scientific computing. While Fortran has been in use since its inception by John Backus at IBM in 1957, it still remains popular today, especially for computationally intensive applications including numerical weather prediction, finite element analysis, computational fluid dynamics, computational physics, crystallography, and computational chemistry. Despite its age, new language revisions include syntax and semantics for modern language ideas including pointers, recursion, object orientated programming features, and parallel programming using Coarray Fortran.
- GitHub: https://github.com/topics/fortran
- Wikipedia: https://wikipedia.org/wiki/Fortran
- Repo: https://github.com/j3-fortran
- Created by: John W. Backus
- Released: April 1957
- Related Topics: mpi, coarrays, coarray-fortran, hpc, high-performance-computing, c, compiler, finite-element-method,
- Aliases: f95, f77, fortran90, fortran77, fortran95, fortran2003, fortran2008, fortran2018,
- Last updated: 2025-01-22 00:11:18 UTC
- JSON Representation
https://github.com/lkedward/quickstart-fortran
An easy Windows installer for GFortran and the Fortran Package Manager
fortran fortran-compiler fortran-package-manager gcc gfortran lapack openblas windows
Last synced: 08 Nov 2024
https://github.com/jacobwilliams/finterp
Multidimensional (1D-6D) Linear and Nearest-Neighbor Interpolation with Modern Fortran
fortran fortran-package-manager interpolation linear-interpolation nearest-neighbor-interpolation
Last synced: 30 Dec 2024
https://github.com/underworldcode/stripy
2D spherical and Cartesian triangulation toolkit using tripack, stripack, srfpack and ssrfpack
fortran meshes python spherical-geometry triangulation-delaunay
Last synced: 10 Jan 2025
https://github.com/jeng1220/openacc_fortran_examples
Simple OpenACC Fortran Examples
Last synced: 28 Oct 2024
https://github.com/Par4All/par4all
Par4All is an automatic parallelizing and optimizing compiler (workbench) for C and Fortran sequential programs
abstract-interpretation automatic-parallelization c99 cuda fortran interprocedural opencl parallelization polyhedral-model
Last synced: 09 Nov 2024
https://github.com/par4all/par4all
Par4All is an automatic parallelizing and optimizing compiler (workbench) for C and Fortran sequential programs
abstract-interpretation automatic-parallelization c99 cuda fortran interprocedural opencl parallelization polyhedral-model
Last synced: 12 Oct 2024
https://github.com/ctuning/ctuning-programs
Collective Knowledge extension with unified and customizable benchmarks (with extensible JSON meta information) to be easily integrated with customizable and portable Collective Knowledge workflows. You can easily compile and run these benchmarks using different compilers, environments, hardware and OS (Linux, MacOS, Windows, Android). More info:
c collaborative-benchmarking collaborative-optimization collective-knowledge common-benchmarks cpp crowd-benchmarking crowd-tuning cuda customizable-benchmarking fortran json-api json-metadata open-benchmarks opencl reproducible-research reproducible-workflows
Last synced: 13 Nov 2024
https://github.com/jacobwilliams/dop853
Modern Fortran Edition of Hairer's DOP853 ODE Solver. An explicit Runge-Kutta method of order 8(5,3) for problems y'=f(x,y); with dense output of order 7
dop853 fortran fortran-package-manager ode runge-kutta
Last synced: 30 Dec 2024
https://github.com/csdms/bmi
The Basic Model Interface is a standardized set of functions allowing coupling of models to models and models to data
bmi c csdms cxx fortran geosciences interface java javascript julia numerical-modeling python
Last synced: 16 Jan 2025
https://github.com/jefflarkin/openacc-interoperability
Interoperability examples for OpenACC.
Last synced: 05 Dec 2024
https://github.com/jacobwilliams/odepack
Work in Progress to refactor and modernize the ODEPACK Library
fortran ode ode-solver odepack
Last synced: 30 Dec 2024
https://github.com/vacumm/sphinx-fortran
Fortran domain and autodoc extensions to Sphinx
documentation fortran numpy sphinx-doc sphinx-extension
Last synced: 11 Nov 2024
https://github.com/camfort/fortran-src
Fortran parsing and static analysis infrastructure
automated-refactoring fortran haskell parser static-analysis
Last synced: 27 Dec 2024
https://github.com/beliavsky/fortran-tools-on-github
Fortran compilers, preprocessors, static analyzers, transpilers, IDEs, build systems, etc.
compilers fortran interoperability python
Last synced: 03 Dec 2024
https://github.com/CodethinkLabs/ofc
Open Fortran Compiler
compiler fortran fortran77 static-code-analyzer transpiler
Last synced: 09 Nov 2024
https://github.com/gjbex/fortran-mooc
Material related to the PRACE MOOC on Fortran programming
education fortran fortran-tutorial fortran2008 fortran2018 learning scientific-computing
Last synced: 22 Nov 2024
https://github.com/thealgorithms/fortran
All Algorithms implemented in Fortran. Making Fortran Great Again!
algorithm algorithms algorithms-and-data-structures challenge coding data-structures fortran fortran90 hacktoberfest thealgorithms thealgorithms-fortran tutorial
Last synced: 11 Jan 2025
https://github.com/beliavsky/burkardt-fortran-90
Classification of John Burkardt's many Fortran 90 codes
approximation cluster-analysis combinatorics computational-geometry delaunay-triangulation eigenvalues fortran fortran90 graph-algorithms interpolation linear-algebra nonlinear-equations numerical-integration numerical-methods numerical-optimization ode probability-distribution random-number-generators root-finding special-functions
Last synced: 03 Dec 2024
https://github.com/zedthree/fort_depend.py
A python script to generate dependencies for Fortran projects
build-tool dependency-graph fortran makefile python
Last synced: 18 Jan 2025
https://github.com/urbanjost/general-purpose-fortran
General Purpose Fortran Cooperative
fortran fortran-package-manager fpm library repository
Last synced: 30 Dec 2024
https://github.com/aimukhin/minfft
A small and fast Discrete Fourier Transform library
c cooley-tukey cosine dct dft dst fft fortran multi-dimensional sine
Last synced: 19 Nov 2024
https://github.com/yizhang-yiz/fazang
Fazang is a Fortran library for reverse-mode automatic differentiation, inspired by Stan/Math library.
autodiff autodifferentiation automatic-differentiation fortran
Last synced: 12 Nov 2024
https://github.com/molgw/molgw
Accurate many-body perturbation theory calculations of the electronic structure of molecules and clusters
bethe-salpeter dft fortran greens-functions hartree-fock molecule mpi quantum-mechanics scalapack tddft
Last synced: 15 Jan 2025
https://github.com/lkedward/focal
A modern Fortran abstraction layer for OpenCL
fortran fortran-library fortran-modules fortran2003 fortran2008 opencl opencl-api
Last synced: 30 Dec 2024
https://github.com/jacobwilliams/nlesolver-fortran
Nonlinear Equation Solver with Modern Fortran
broyden-method differential-correction-algorithm fortran fortran-package-manager lsmr lsqr lusol minimum-norm newton-raphson nonlinear-equation-solver nonlinear-equations quasi-newton
Last synced: 30 Dec 2024
https://github.com/ivan-pi/fmetis
A modern Fortran interface to the METIS graph partitioning library
fortran graph graph-partitioning mesh-partitioning metis partitioning reordering serial sparse-matrix
Last synced: 06 Dec 2024
https://github.com/annefou/fortran
Fortran materials
fortran fortran-materials fortran2003
Last synced: 10 Jan 2025
https://github.com/lkedward/fhash
fpm package implementing a hash table with support for generic keys and values.
fortran fortran-package-manager fpm hashmap hashtable
Last synced: 30 Dec 2024
https://github.com/14ngiestas/mfi
Modern Fortran Interfaces to BLAS and LAPACK
blas fortran interfaces-fortran lapack linear-algebra modern-fortran
Last synced: 06 Dec 2024
https://github.com/loftytopping/PyBox
A box-model that automatically creates and solves equations used to describe the evolution in atmospheric composition using Python with Numba and, optionally, Fortran.
atmospheric-science chemistry fortran numba
Last synced: 05 Nov 2024
https://github.com/dlr-sc/f2x
A versatile, template-based FORTRAN wrapper written in Python.
fortran fortran-wrappers hpc hybrid-programming python wrapper
Last synced: 08 Nov 2024
https://github.com/jacobwilliams/pikaia
Modern Fortran Edition of the Pikaia Genetic Algorithm
fortran fortran-package-manager genetic-algorithm numerical-optimization optimization pikaia
Last synced: 30 Dec 2024
https://github.com/jacobwilliams/roots-fortran
A modern Fortran library for finding the roots of continuous scalar functions of a single real variable, using derivative-free methods.
bisection brent-dekker fortran fortran-package-manager muller muller-s-method regula-falsi root-finding zeroin
Last synced: 30 Dec 2024
https://github.com/smwesten-usgs/swb
Soil-Water-Balance: A Modified Thornthwaite-Mather Soil-Water-Balance Code for Estimating Groundwater Recharge.
deep-percolation fortran groundwater-recharge soil-water-balance usgs
Last synced: 27 Nov 2024
https://github.com/jacobwilliams/powellopt
Optimization algorithms by M.J.D. Powell
constrained-optimization fortran fortran-package-manager nonlinear-optimization numerical-optimization optimization unconstrained-optimization
Last synced: 30 Dec 2024
https://github.com/jacobwilliams/quadrature-fortran
1D-6D Adaptive Gaussian Quadrature with Modern Fortran
fortran fortran-package-manager integration numerical-integration quadrature quadrature-integration
Last synced: 30 Dec 2024
https://github.com/p-costa/snac
A multi-block solver for massively parallel direct numerical simulations (DNS) of fluid flows
cfd computational-fluid-dynamics fluid-dynamics fluid-simulation fortran high-performance-computing turbulence
Last synced: 30 Dec 2024
https://github.com/grimme-lab/qc2-teaching
Resources for teaching quantum chemistry courses in Bonn
educational fortran fortran-tutorial learning quantum-chemistry teaching
Last synced: 03 Dec 2024
https://github.com/jacobwilliams/ddeabm
Modern Fortran implementation of the DDEABM Adams-Bashforth algorithm
adams-bashforth fortran fortran-package-manager ode root-finding slatec
Last synced: 30 Dec 2024
https://github.com/fortran-lang/fpm-docs
Documentation repository for the Fortran package manager (fpm)
documentation fortran fortran-package-manager fortran-tutorial fpm
Last synced: 30 Dec 2024
https://github.com/interkosmos/fortran-sdl2
Fortran 2008 interface bindings to SDL 2.0
fortran fortran-package-manager fpm game-development gamedev opengl sdl sdl2
Last synced: 08 Nov 2024
https://github.com/expander/polylogarithm
Implementation of polylogarithms in C/C++/Fortran
c cplusplus cpp fortran math mit-license polylogarithm special-functions
Last synced: 28 Oct 2024
https://github.com/jacobwilliams/fortran_function_parser
Modern Fortran function parser. An update of "fparser" by Roland Schmehl
expression-parser fortran function-parser
Last synced: 30 Dec 2024
https://github.com/mjucker/MiMA
Model of an idealized Moist Atmosphere: Intermediate-complexity General Circulation Model with full radiation
atmospheric-modelling atmospheric-science climate-model fortran gcm
Last synced: 27 Nov 2024
https://github.com/fortran-lang/playground
An interactive Fortran playground
Last synced: 08 Nov 2024
https://github.com/tschoonj/xmimsim
Monte Carlo simulation of energy-dispersive X-ray fluorescence spectrometers
c fortran monte-carlo-simulation x-ray-fluorescence x-ray-physics x-ray-spectroscopy
Last synced: 07 Nov 2024
https://github.com/interkosmos/fortran-curl
Fortran 2008 interface bindings to libcurl
curl fortran fortran-2008 fortran-package-manager fpm gopher http imap libcurl mqtt smtp
Last synced: 14 Oct 2024
https://github.com/cphyc/fortran-linter
A simple fortran syntax checker, including automatic fixing of the code.
Last synced: 22 Jan 2025
https://github.com/pkestene/euler2d_cudafortran
2nd order Godunov solver for 2d Euler equations written in CUDA Fortran and stdpar (standard paralelism)
cea conservation-laws cuda cuda-fortran euler-equations fortran gpu gpu-computing hydrodynamics nvfortran nvhpc stdpar
Last synced: 18 Dec 2024
https://github.com/johnsonjh/matlab
matlab: MATLAB (with FORTRAN source code)
1982 fortran historical history matlab source-code
Last synced: 27 Oct 2024
https://github.com/zoziha/sph
💦光滑粒子流体动力学代码(🌊A smoothed particle hydrodynamics (SPH) code)
cfd fortran fpm meshfree meshless modern-fortran navier-stokes smoothed-particle-hydrodynamics sph
Last synced: 30 Dec 2024
https://github.com/jterwin/HDF5_utils
my own Fortran high level interface for HDF5
Last synced: 20 Nov 2024
https://github.com/interkosmos/fortran-unix
Fortran 2008 interface bindings to selected POSIX and SysV procedures
fortran fortran-2008 fortran-package-manager fpm freebsd linux posix unix
Last synced: 08 Nov 2024
https://github.com/scivision/python-performance
Performance benchmarks of Python, Numpy, etc. vs. other languages such as Matlab, Julia, Fortran.
benchmark fortran gfortran julia matlab microbenchmark numba numpy performance
Last synced: 31 Oct 2024
https://github.com/ipqa-research/yaeos
Thermodynamic Equations of State, Fortran library with both automatic and anallytical derivation capabilities
automatic-differentiation equation-of-state fortran fortran-package-manager nrtl peng-robinson rkpr soaveredlichkwong thermodynamics unifac
Last synced: 13 Jan 2025
https://github.com/certik/hfsolver
Hartree Fock solver
density-functional-theory electronic-structure fortran hartree-fock
Last synced: 08 Nov 2024
https://github.com/jacobwilliams/pchip
Modern Fortran Piecewise Cubic Hermite Interpolation Package
fortran fortran-package-manager hermite-interpolation interpolation slatec
Last synced: 30 Dec 2024
https://github.com/interkosmos/fortran-sqlite3
Fortran 2018 interface bindings to SQLite 3
fortran fortran-package-manager fpm sqlite sqlite3
Last synced: 08 Nov 2024
https://github.com/jacobwilliams/lsqr
Modern Fortran sparse linear systems solver
conjugate-gradient fortran fortran-package-manager least-squares linear-algebra linear-equations lsqr
Last synced: 30 Dec 2024
https://github.com/pdebuyl/fortran_tester
Fortran module to test Fortran programs
Last synced: 13 Jan 2025
https://github.com/pseewald/fortran-einsum-example
A generic implementation of tensor einsum in Fortran.
einsum fortran generic-programming tensor
Last synced: 15 Jan 2025
https://github.com/jacobwilliams/fortran-search-and-sort
Searching and sorting with modern Fortran
binary-search fortran quicksort searching-algorithms sorting-algorithms
Last synced: 08 Nov 2024
https://github.com/urbanjost/m_strings
Fortran string manipulations
fortran fortran-package-manager fpm string-manipulation strings
Last synced: 30 Dec 2024
https://github.com/aradi/fortuno.old
User friendly, flexible and extensible object-oriented Fortran unit testing framework for testing serial, MPI-parallelized and coarray-parallelized applications
fortran fortran2018 object-oriented-programming unittest
Last synced: 30 Dec 2024
https://github.com/jacobwilliams/daglib
Directed Acyclic Graphs With Modern Fortran
directed-acyclic-graph fortran fortran-package-manager graphviz graphviz-dot-language toposort
Last synced: 30 Dec 2024
https://github.com/robintw/PyProSAIL
Python interface to the ProSAIL leaf/canopy reflectance model
fortran python satellite science vegetation
Last synced: 15 Nov 2024
https://github.com/robintw/pyprosail
Python interface to the ProSAIL leaf/canopy reflectance model
fortran python satellite science vegetation
Last synced: 21 Dec 2024
https://github.com/ivan-pi/stiff3
Adaptive solver for stiff systems of ODEs using semi-implicit Runge-Kutta method of third order
adaptive differential equation fortran ode solver stiff
Last synced: 06 Dec 2024
https://github.com/space-physics/grwave
Python for ITU P.368 : Ground-wave propagation curves for frequencies between 10 kHz and 30 MHz
basic-programming-language broadcast fortran geoscience itu medium-wave propagation python shortwave
Last synced: 14 Dec 2024
https://github.com/jacobwilliams/simulated-annealing
Simulated Annealing with Modern Fortran
annealing fortran optimization simulated-annealing stochastic-optimization
Last synced: 30 Dec 2024
https://github.com/tmm1/taxsim.js
JS/WebAssembly version of NBER TAXSIM
fortran tax-calculator webassembly
Last synced: 14 Jan 2025
https://github.com/jacobwilliams/stl-fortran
Fortran STL File I/O
3d-models fortran stereolithography stl stl-fortran
Last synced: 30 Dec 2024
https://github.com/nomad-coe/greenx
Library for Green’s function based electronic structure theory calculations
exascale fortran greens-functions
Last synced: 08 Jan 2025
https://github.com/jacobwilliams/polyroots-fortran
Modern Fortran library for finding the roots of real and complex polynomial equations
companion-matrix eigenvalues fortran fortran-package-manager jenkins-traub laguerre-method nonlinear-equations polynomial-equations polynomial-roots polynomials root-finding
Last synced: 30 Dec 2024
https://github.com/dceresoli/ce-tddft
Real-time TDDFT for Quantum-Espresso
dft fortran quantum-dynamics quantum-espresso quantum-mechanics tddft
Last synced: 20 Nov 2024
https://github.com/vmagnin/forsynth
A small Fortran synthesizer to explore sound synthesis, sound effects, electronic music, algorithmic music, etc. Humbly follow the steps of Stockhausen, Kraftwerk and the Daft Punk!
fortran fortran-package-manager music sound synthesis synthesizer
Last synced: 12 Dec 2024
https://github.com/rjfarmer/pyMesa
Allows python to interface with MESA
astrophysics bindings fortran mesa python
Last synced: 23 Oct 2024
https://github.com/geoschem/gchp
The "superproject" wrapper repository for GCHP, the high-performance instance of the GEOS-Chem chemical-transport model.
aerosols atmospheric-chemistry atmospheric-composition atmospheric-science carbon-cycle climate earth-science earth-system-model esmf fortran gchp geos-chem greenhouse-gases hg mpi
Last synced: 09 Jan 2025
https://github.com/0382/argparse-f
Modern Fortran command line parser, implemented with OOP.
argparse command-line fortran modern-fortran oop
Last synced: 28 Dec 2024
https://github.com/gha3mi/forcad
ForCAD - A Fortran library for Geometric Modeling
bezier bsplines cad curves fortran fortran-package-manager nurbs surfaces volumes
Last synced: 12 Dec 2024
https://github.com/vmagnin/forcolormap
A Fortran library for colormaps
colormaps fortran fortran-package-manager
Last synced: 12 Dec 2024
https://github.com/urbanjost/m_cli2
Fortran commandline-interface using a simple prototype command
argument command-line fortran fortran-package-manager parsing
Last synced: 30 Dec 2024
https://github.com/gnikit/findent-pypi
Generates the PyPi wheels for findent
Last synced: 06 Dec 2024
https://github.com/geospace-code/h5fortran-mpi
HDF5-MPI parallel Fortran object-oriented interface
fortran hdf5 mpi mpi-applications object-oriented-fortran
Last synced: 11 Jan 2025
https://github.com/vmagnin/exploring_coarrays
Let's explore the modern Fortran features for parallel programming (coarrays, images, collective subroutines...)
coarray-fortran coarrays fortran openmp
Last synced: 12 Dec 2024
https://github.com/jeffhammond/vapaa
A standalone implementation of the MPI Fortran 2018 module
Last synced: 05 Dec 2024
https://github.com/flang-compiler/classic-flang-llvm-project
LLVM monorepo for integration with classic flang
compiler fortran fortran-compiler llvm
Last synced: 20 Dec 2024
https://github.com/lanl/flpr
FLPR: The Fortran Language Program Remodeling system
code-manipulation cpp cpp17 fortran fortran-language fortran2018 frontend library parser source-code-analysis source-code-manipulation source-generation source-manipulation source-to-source syntactic-analysis syntax-analysis
Last synced: 09 Dec 2024
https://github.com/sintef/fortran-error-handling
A library for flexible and easy to use error handling in Fortran projects
error-handling fortran fortran-package-manager
Last synced: 12 Jan 2025
https://github.com/zbeekman/zstdfortranlib
👨💻Zaak's 🧩(missing) 🏛Standard 🔬Fortran 📚Library 🚧(WIP)
convenience fortran fortran-library fortran-modules fortran2003 fortran2008 fortran2018 productivity syntactic-sugar
Last synced: 21 Jan 2025