Ecosyste.ms: Awesome
An open API service indexing awesome lists of open source software.
Fortran
![](https://explore-feed.github.com/topics/fortran/fortran.png)
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-02-07 00:11:34 UTC
- JSON Representation
https://github.com/starlink/aspic
Starlink Image processing programs from the 1980s
Last synced: 05 Jan 2025
https://github.com/jacobwilliams/nrlmsis2.1
Unofficial Mirror of NRLMSIS2.1 https://map.nrl.navy.mil/map/pub/nrl/NRLMSIS/NRLMSIS2.1/
atmosphere-model fortran nrlmsise00
Last synced: 30 Dec 2024
https://github.com/gha3mi/forbenchmark
ForBenchmark - A Fortran library for benchmarking (with support for coarrays).
benchmark coarray fortran fortran-package-manager
Last synced: 06 Feb 2025
https://github.com/globalpolicy/flownet
Flownet generation with Fortran
equation equipotential flownet fortran groundwater laplace
Last synced: 19 Dec 2024
https://github.com/awvwgk/fpm-artwork
Artwork and resources created in the context of the Fortran package manager (fpm)
artwork fortran public-domain svg-images
Last synced: 19 Dec 2024
https://github.com/ssoehdata/cuda_fortran_sci_eng
Working through examples from the Cuda Fortran for Scientists and Engineers 2nd Edition Book
cuda cuda-fortran fortran hpc nvfortran
Last synced: 10 Dec 2024
https://github.com/thisalmandula/gpu_accelerated_lpt_cfd_code
This repository contains GPU accelerated version of the particle tracking model developed by Merel Kooi for biofouled microplastic particles ( available at: https://pubs.acs.org/doi/10.1021/acs.est.6b04702) written in CUDA Fortran and CUDA Python. This repository is intended as a learning tool for GPU programming.
biofouling computational-fluid-dynamics cuda fortran lagrangian-particle-tracking microplastics python
Last synced: 02 Feb 2025
https://github.com/truong-pham-dang/hello
Some Fortran codes to practice programming in Fortran.
cuda-fortran fortran mpi mpi-library openacc
Last synced: 23 Oct 2024
https://github.com/csdms/bmi-f90
Fortran bindings for the Basic Model Interface
Last synced: 02 Jan 2025
https://github.com/awvwgk/foopss
4th Seminar of the ESL Fortran OOP Seminar Series: Using objects across language boundaries
c-bindings fortran fortran-tutorial interoperability object-oriented-programming python-bindings
Last synced: 20 Dec 2024
https://github.com/trixi-framework/paper-2021-ec_performance
Reproducibility repository for "Efficient implementation of modern entropy stable and kinetic energy preserving discontinuous Galerkin methods for conservation laws"
conservation-laws discontinuous-galerkin fortran julia simd
Last synced: 20 Jan 2025
https://github.com/pdebuyl/random_module
A modular and version controlled implementation of the Mersenne Twister
fortran mersenne-twister random-number-generators threefry
Last synced: 13 Jan 2025
https://github.com/stdlib-js/blas-base-matrix-triangles
BLAS matrix triangles.
array blas c fortran javascript matrix multidimensional ndarray node node-js nodejs stdlib triangle triangular types util utilities utility utils
Last synced: 17 Oct 2024
https://github.com/stdlib-js/blas-base-transpose-operations
List of BLAS transpose operations.
array blas c fortran javascript multidimensional ndarray node node-js nodejs operation stdlib transpose transposition types util utilities utility utils
Last synced: 17 Oct 2024
https://github.com/fedebenelli/fortimize
General Fortran API for optimization routines
fortran fortran- gradient-descent nelder-mead optimization optimization-algorithms
Last synced: 06 Jan 2025
https://github.com/upc-ghs/gslib-executables
GSLIB executables for windows and linux (x64)
executables fortran geostatistics gslib
Last synced: 31 Jan 2025
https://github.com/lewisjared/fgen-example
Example of fgen-wrapped fortran code
Last synced: 15 Oct 2024
https://github.com/upc-ghs/modpath-omp
MODPATH-v7 plus parallel particles processing with OpenMP
fortran hydrogeology modflow modpath particle-tracking
Last synced: 31 Jan 2025
https://jchristopherson.github.io/collections/
A set of types supporting collections in Fortran.
collection collections fortran generic-collections generic-list linked-list list lists
Last synced: 01 Nov 2024
https://github.com/stdlib-js/ndarray-base-assert-is-column-major
Given a stride array, determine whether an array is column-major.
assert base check column-major fortran fortran-order javascript ndarray node node-js nodejs order row-major stdlib strides test types valid validate validation
Last synced: 03 Dec 2024
https://github.com/tallamjr/computing-for-scientists-book
Exercises and code from Computing for Scientists Book.
Last synced: 17 Dec 2024
https://github.com/zoziha/nnps
NNPS scheme practice in CFD particle method.🌲
Last synced: 30 Dec 2024
https://github.com/zoziha/ampd-algorithm
Automatic Multiscale-based Peak Detection (AMPD) Algorithm
fortran fortran-package-manager matlab python
Last synced: 30 Dec 2024
https://github.com/everythingfunctional/erloff
Errors and logging for fortran
error-handling fortran logging
Last synced: 30 Dec 2024
https://github.com/jacobwilliams/fortran-mach
Modern Fortran Machine Constants Module (r1mach, d1mach, i1mach)
Last synced: 30 Dec 2024
https://github.com/jacobwilliams/novas
Refactoring of NOVAS: Naval Observatory Vector Astrometry Subroutines
astronomy fortran fortran-package-manager novas us-navy usno
Last synced: 30 Dec 2024
https://github.com/jacobwilliams/ffp
Unofficial mirror of Fortran Function Parser from http://www.labfit.net/functionparser.htm
expression-parser fortran function-parser
Last synced: 30 Dec 2024
https://github.com/jacobwilliams/aoc-2022
Advent of Code 2022 in Fortran
advent-of-code-2022 aoc-2022 aoc-2022-in-fortran fortran
Last synced: 30 Dec 2024
https://github.com/interkosmos/lucifer
Lucifer block cipher in FORTRAN 77
cipher cryptography des encryption fortran fortran-77 lucifer
Last synced: 30 Dec 2024
https://github.com/interkosmos/f77-3d
Very basic 3D engine in FORTRAN 77 for MS-DOS
dos fortran fortran-77 raycasting
Last synced: 30 Dec 2024
https://github.com/urbanjost/m_fixedform
create fixed-form TDU interfaces using ncurses(3c) from Fortran
fortran fortran-package-manager ncurses tui
Last synced: 30 Dec 2024
https://github.com/urbanjost/m_color
convert between RGB color values and other common color models
color-conversion color-models fortran fortran-package-manager
Last synced: 30 Dec 2024
https://github.com/ipqa-research/fortrancodespace
codespace-template fortran fortran-package-manager fpm
Last synced: 13 Jan 2025
https://github.com/camfort/fortran-src-extras
Various utility functions and orphan instances which may be useful when using fortran-src.
fortran haskell static-analysis
Last synced: 20 Jan 2025
https://github.com/owainkenwayucl/minipi
Versions of the pi example for slightly less hospitable environments.
basic calculating-pi fortran fortraniv maclisp sc ulisp xlisp
Last synced: 28 Jan 2025
https://github.com/owainkenwayucl/cobol-rand
Experiment showing that Ubuntu Xenial's open-cobol package has a broken RNG
bug cobol fortran rng ubuntu ubuntu-packages
Last synced: 28 Jan 2025
https://github.com/owainkenwayucl/mandel
Various code to generate mandelbrot sets.
benchmark c common-lisp fortran go javascript julia mandelbrot pgm python r swift
Last synced: 28 Jan 2025
https://github.com/azimonti/ma-libs
A set of libraries and tool in C++ and Fortran, developed during the years, that can be reused in other projects
cpp fortran hdf5 lapack neural-networks opengl opengl-engine python python-bindings
Last synced: 20 Jan 2025
https://github.com/scivision/cmake-fetchcontent
A dummy repo used by scivision/cmake-utils demonstrating modern CMake and Fortran distribution
Last synced: 23 Jan 2025
https://github.com/lu1zedu/fortran
Esse repositorio coloca todos os projetos em Fortran e toda a minha evolução
Last synced: 24 Jan 2025
https://github.com/awikramanayake/lookup-optimization
A sandbox to speed up maths intensive python steps from other projects using Fortran/C++ and parallelization.
Last synced: 29 Jan 2025
https://github.com/gasinan/fdata2pyplot
A simple Fortran module for passing Fortran output to a Python script for later using Matplotlib to make figure
Last synced: 29 Jan 2025
https://github.com/beliavsky/computer-methods-for-mathematical-computations
Code from the book of the same name by Forsythe, Malcolm, and Moler, translated to Fortran 90 by Ralph Carmichael
book-code cubic-splines fortran fortran90 linear-algebra minimization numerical-integration numerical-methods ode root-finding svd
Last synced: 30 Jan 2025
https://github.com/beliavsky/fortrancode
Various Fortran codes
binomial fortran monte-carlo negative-binomial negative-binomial-distribution rng
Last synced: 30 Jan 2025
https://github.com/beliavsky/desired_fortran_software
List of algorithms I'd like to see in modern Fortran
Last synced: 30 Jan 2025
https://github.com/beliavsky/fortran_faq
originally the comp.lang.fortran FAQ from January 1997 by Keith Bierman
Last synced: 30 Jan 2025
https://github.com/beliavsky/timeslab
Mirror of Timeslab Fortran 77 time series package by H. Joseph Newton
fortran statistics time-series time-series-analysis timeseries
Last synced: 30 Jan 2025
https://github.com/beliavsky/fortran-calling-c-for-io
speed comparison of Fortran internal read with Fortran calling C atoi() function
atoi c fortran string string-conversion
Last synced: 30 Jan 2025
https://github.com/vmagnin/penrose_tiling
This project generates a SVG file with a Penrose tiling, using the cairo-fortran bindings.
cairo fortran fortran-package-manager penrose-tilings
Last synced: 06 Feb 2025
https://github.com/raleighlittles/projecteuler-fortran
A repository of solutions to Project Euler problems, written in FORTRAN 95.
fortran fortran95 project-euler
Last synced: 26 Jan 2025
https://github.com/beliavsky/ezup
August Miller's tool to convert Fortran fixed source form to free source form to be compatible with ELF90
fortran transpiler transpiler-for-casual-use
Last synced: 30 Jan 2025
https://github.com/beebus/hello-world-fortran
Using an Ubuntu Linux text editor, I followed a "hello world" tutorial at https://fortran-lang.org/learn/quickstart/hello_world
fortran fortran90 hello-world helloworld
Last synced: 06 Feb 2025
https://github.com/thomasms/fortc
Fortran to C (and back again) examples
bindings c cpp fortran iso modern-fortran
Last synced: 03 Feb 2025
https://github.com/thomasms/fortsraw
Native data structures for modern Fortran
data-structures fortran fortran2008 ftl linked-list
Last synced: 03 Feb 2025
https://github.com/facthunder/icode
Docker image for i-Code CNES
analyzer code-analysis docker docker-image fortran fortran77 fortran90 i-code i-code-cnes rnc shell static-analysis
Last synced: 06 Feb 2025
https://github.com/aantusahaa/fortran-lab
This repository contains a collection of numerical methods implemented in modern Fortran. These methods are widely used in scientific computing, engineering simulations, and mathematical problem-solving.
fortran numerical-analysis numerical-methods
Last synced: 06 Feb 2025
https://github.com/gha3mi/forinv
ForInv - A Fortran library for inverse and pseudo-inverse calculations.
fortran fortran-package-manager inverse pseudoinverse svd
Last synced: 06 Feb 2025
https://github.com/wiremoons/adventofcode2015
Solutions for Advent of Code puzzles: https://adventofcode.com/2015
aoc aoc-2015-in-cpp aoc-2015-in-deno aoc2015 cpp20 deno fortran typesctipt
Last synced: 26 Dec 2024
https://github.com/miladsade96/numermp
Multi-threaded numerical methods implemented in fortran and wrapped in python
fortran fortran90 mathematical-programming mathematics multithreading numerical-analysis numerical-methods openmp parallel-computing python
Last synced: 03 Jan 2025
https://github.com/thesgj/cointoss-fortran
This program implements a simple coin tossing game where the user guesses the outcome of a coin toss. The game should toss a coin 1 times and add the score.
fortran fortran90 github-copilot mlh mlh-hackathon
Last synced: 07 Feb 2025
https://github.com/vmagnin/gtkzero_fpm
We demonstrate how gtk-fortran can be used as a fpm (Fortran Package Manager) dependency.
fortran fortran-package-manager gtk gtk-fortran gui
Last synced: 04 Jan 2025
https://github.com/matthalex/mpi-project-exploration
A sample Fortran MPI project for a Cartesian decomposition with halo regions.
fortran modernfortran mpi vscode
Last synced: 30 Jan 2025
https://github.com/somajitdey/cross-product
One-liner array expression to determine the cross-product of two 3-dimensional vectors. Fast computation of inverse of 3x3 matrix using this expression.
cross-product fortran matrix-inversion
Last synced: 07 Feb 2025
https://github.com/somajitdey/f_
A KISS library for extending standard Fortran in a portable way
fortran fortran-library fortran-modules library posix stdlib syscall syscalls system systemcall systemcalls utility utility-library
Last synced: 07 Feb 2025
https://github.com/reyrove/fortran
Welcome! This repo offers simple Fortran 95 examples for key algorithms and numerical methods. Learn with Plato IDE and FTN95. For more, check out my YouTube tutorials!
compiler fortran fortran-language fortran-tutorial fortran77 fortran90 fortran95 freyja mathematics numerical-computation plato programming reyrove youtube
Last synced: 24 Jan 2025
https://github.com/ismoreirakt/fortrant
Vscode plugin that offers syntax highlighting for fortran.
fortran vscode-extension vscode-plugin
Last synced: 07 Feb 2025
https://github.com/e3sm-project/transport_se
Atmosphere transport mini app
advection climate-model dynamical-core fortran
Last synced: 01 Feb 2025
https://github.com/bbakernoaa/fyaml
Very lightweight native fortran yaml parser
Last synced: 28 Nov 2024
https://github.com/neorai943/freyjafa
Removing barriers to growth and aiding the acceleration of learning engineering skills by examining the history and roots of everything related to engineering.
css education euclid fortran freyja history html javascript matlab programming typesetting website youtube
Last synced: 05 Feb 2025
https://github.com/lross2k/fortran-plot-engranes
Script de Fortran 2003 realizado para validar un problema de mecánica clásica.
Last synced: 06 Feb 2025
https://github.com/alessandropierro/2021assignment01
MPI programming and HPC cluster performance analysis for "Foundations of HPC" course @ University of Trieste
Last synced: 15 Jan 2025
https://github.com/program--/geom
Fortran 2008 Geometry/Topology Engine
fortran geometry geospatial topology
Last synced: 05 Feb 2025
https://github.com/dmitriymakhnovskiy/digital_bh-meter_ni_daq
BH-meter based on NI DAQ and LabVIEW
bh-meter ferromagnetism fortran hysteresis-loop labview labview-gui microwires nidaq nidaqmx numerical-integration pickup-coil taylor-ulitovskiy
Last synced: 06 Jan 2025
https://github.com/caeassistant-group/viscoelastic-abaqus-model-for-the-analysis-of-composite-curing
This project presents an innovative approach for examining residual stresses in composites: The Abaqus viscoelastic model for curing. The implementation of the model is carried out in Abaqus CAE, utilizing Fortran subroutines such as USDFLD, UMAT, HETVAL, UEXPAN, and DISP.
abaqus cae composite curing f90 fortran frc maxwell prony simulation subroutine umat viscoelastic
Last synced: 06 Feb 2025
https://github.com/caeassistant-group/path-dependent-abaqus-model-for-the-analysis-of-composite-curing
This study introduces a novel method for analyzing residual stresses in composite materials: the Abaqus path-dependent curing model. The model is implemented within Abaqus CAE using Fortran subroutines like USDFLD, UMAT, HETVAL, UEXPAN, and DISP.
abaqus cae composite curing f90 fortran frc path-dependent simulation subroutines umat
Last synced: 06 Feb 2025
https://github.com/kassane/ffi-flang-zig
FFI flang-new runtime with Zig
cross-compile ffi ffi-bindings flang fortran llvm zig zig-package
Last synced: 26 Jan 2025
https://github.com/owainkenwayucl/utils
Various small tools that I use to make my life easier.
amstrad amstrad-nc bash file-conversion find fortran fputs hy python srt subtitle-conversion subtitle-formats sum ucblogo youtube-subtitles
Last synced: 28 Jan 2025
https://github.com/geoschem/geos_it
Code to process/regrid the GMAO GEOS-IT data for input into GEOS-Chem
data-download data-processing fortran geos-it meteorology nasa-gmao perl
Last synced: 09 Jan 2025
https://github.com/beliavsky/fortran-non-english-resources
Fortran resources not in English
Last synced: 30 Jan 2025
https://github.com/systemsoftware/fortran-experiments
Random stuff I made with Fortran
Last synced: 28 Jan 2025
https://github.com/thepuppetqueen57/c-bos-fortran
A version of C-Bos made in Fortran
cli command-line fortran toy-project
Last synced: 17 Jan 2025
https://github.com/kneth/mdreac
Molecular Dynamics simulation coupled with chemical reactions
c chemical-reactions fortran molecular-dynamics
Last synced: 28 Dec 2024
https://github.com/suvayu/rust-c-to-fortran-toy-ex
A toy example of how to talk to Fortran from Rust using the C-ABI
c-abi c-language fortran interoperability rust rust-lang
Last synced: 22 Jan 2025