-
rust_decimal
Decimal number implementation written in pure Rust suitable for financial and fixed-precision calculations
-
num-integer
Integer traits and functions
-
bigdecimal
Arbitrary precision decimal numbers
-
nalgebra
General-purpose linear algebra library with transformations and statically-sized or dynamically-sized matrices
-
statrs
Statistical computing library for Rust
-
kurbo
A 2D curves library
-
euclid
Geometry primitives
-
sprs
A sparse matrix library
-
num-complex
Complex numbers implementation for Rust
-
matrixmultiply
General matrix multiplication for f32 and f64 matrices. Operates on matrices with general layout (they can use arbitrary row and column stride). Detects and uses AVX or SSE2 on x86…
-
ruint
Unsigned integer type with const-generic bit length
-
num-rational
Rational numbers implementation for Rust
-
roots
well known algorithms for numerical root finding
-
peroxide
Rust comprehensive scientific computation library contains linear algebra, numerical analysis, statistics and machine learning tools with farmiliar syntax
-
num-bigint-dig
Big integer implementation for Rust
-
bnum
Arbitrary, fixed size numeric types that extend the functionality of primitive numeric types
-
ultraviolet
do linear algebra, fast
-
fend
Arbitrary-precision unit-aware calculator
-
counter
package to count generic iterables
-
good_lp
Mixed Integer Linear Programming for Rust, with an user-friendly API. This crate allows modeling LP problems, and lets you solve them with various solvers.
-
rug
Arbitrary-precision integers, rational, floating-point and complex numbers based on GMP, MPFR and MPC
-
rustc_apfloat
Rust port of C++ llvm::APFloat library
-
self-replace
that allows executables to replace or uninstall themselves
-
argmin
Numerical optimization in pure Rust
-
simple_moving_average
moving average (SMA) algorithms
-
parry3d-f64
3 dimensional collision detection library in Rust. 64-bits precision version.
-
simba
SIMD algebra for Rust
-
hexasphere
evenly tile hexagons on a sphere
-
russell_sparse
Solvers for large sparse linear systems (wraps MUMPS and UMFPACK)
-
num-bigint
Big integer implementation for Rust
-
num-dual
Generalized (hyper) dual numbers for the calculation of exact (partial) derivatives
-
common_traits
Traits to write generic functions on different numeric types, with atomic support, and other features
-
blas-src
The package provides a BLAS source of choice
-
cgmath
A linear algebra and mathematics library for computer graphics
-
kalc
a complex numbers, 2d/3d graphing, arbitrary precision, vector/matrix, cli calculator with real-time output and support for units
-
triton-vm
virtual machine that comes with Algebraic Execution Tables (AET) and Arithmetic Intermediate Representations (AIR) for use in combination with a STARK proof system to allow proving correct…
-
lambda_calculus
zero-dependency implementation of pure lambda calculus in Safe Rust
-
faer
Linear algebra routines
-
num-traits
Numeric traits for generic mathematics
-
mint
Math interoperability standard types
-
russell_lab
Scientific laboratory for linear algebra and numerical mathematics
-
num-modular
efficient integer division and modular arithmetic operations with generic number types. Supports various backends including num-bigint, etc
-
splr
A modern CDCL SAT solver in Rust
-
ode_solvers
Numerical methods to solve ordinary differential equations (ODEs) in Rust
-
yata
Technical Analysis library. For rust now.
-
ndrustfft
N-dimensional FFT, real-to-complex FFT and real-to-real DCT
-
fpdec
Decimal fixed-point arithmetic
-
jlrs
bindings to the Julia C API that enable Julia code to be called from Rust and more
-
rapier2d
2-dimensional physics engine in Rust
-
lambdascript
Educational tool illustrating beta reduction of typed and untyped lambda terms, parser generation
-
skillratings
Calculate a player's skill rating using algorithms like Elo, Glicko, Glicko-2, TrueSkill and many more
-
rsc
A fast calculator for solving scientific and algebraic math equations in strings
-
num-bigfloat
Increased precision floating point numbers implemented purely in Rust
-
concrete-fft
pure Rust high performance fast Fourier transform library
-
joker_calculus
Joker Calculus in Rust
-
sci-rs
Rust scientific analysis library similar to SciPy
-
openblas-src
The package provides a source of BLAS and LAPACK via OpenBLAS
-
coin_cbc
Rust bindings to the CoinOR CBC MILP Solveur using the C API
-
russell_tensor
Tensor analysis, calculus, and functions for continuum mechanics
-
glamour
Strongly typed linear algebra with glam
-
maths-rs
A linear algebra library for gamedev and graphics
-
num-quaternion
Quaternion numbers implementation for Rust
-
quaternion-core
quaternion operations and interconversion with several attitude representations
-
plotpy
Rust plotting library using Python (Matplotlib)
-
noisy_float
Contains floating point types that panic if they are set to an illegal value, such as NaN
-
lstsq
Return the least-squares solution to a linear matrix equation
-
glyph_brush_layout
Text layout for ab_glyph
-
russell_ode
Solvers for ordinary differential equations and differential algebraic equations
-
sliding_features
Modular sliding window with various signal processing functions and technical indicators
-
hooo
Propositional logic with exponentials
-
orx-priority-queue
Priority queue traits and high performance d-ary heap implementations
-
feanor-math
number theory, providing implementations for the arithmetic in various rings and algorithms working on them
-
grb
API for Gurobi optimizer
-
lapack
The package provides wrappers for LAPACK (Fortran)
-
ganesh
Function minimization in Rust, simplified
-
bva
manipulating and doing arithmetics on bit vectors of fixed but arbitrary size
-
scientific
Arbitrary precision scientific number (no_std capable, in pure Rust)
-
quaternion
type agnostic quaternion math library designed for reexporting
-
quantities
Unit-safe computations with quantities
-
number_prefix
numeric prefixes (kilo, giga, kibi)
-
incr_stats
Fast, scalable, incremental descriptive statistics in Rust
-
nextsv
Next semantic version calculator
-
reckoner
A high level arbitrary precision arithmetic library supporting integer and rational numbers
-
gauss-quad
applying Gaussian quadrature to integrate a function
-
rl-core
Core logic for a token-bucket rate-limiter
-
ncube
Generalized Hypercube Visualizer
-
stlrs
Seasonal-trend decomposition for Rust
-
krabmaga
A modern developing art for reliable and efficient Agent-based Model (ABM) simulation with the Rust language
-
primal-check
Fast standalone primality testing
-
rust-cli-calculator
calculator written in Rust as a learning project
-
RustedSciThe
RustedSciThe is a Rust library for symbolic and numerical computing: parse string expressions in symbolic representation/symbolic function and compute symbolic (analytical) derivatives…
-
oxidd-cli
Command line interface for OxiDD
-
hyperdual
Fully-featured Dual Number implementation with features for automatic differentiation of multivariate vectorial functions
-
enterpolation
creating and computing interpolations, extrapolations and smoothing of generic data points
-
RustQuant_autodiff
quantitative finance
-
clarabel
Conic Interior Point Solver for Rust / Python
-
unleash-yggdrasil
Unleash SDK domain logic extracted into a library to facilitate building your own Unleash SDKs in anything, anywhere
-
gemlab
Geometry and meshes laboratory for finite element analyses
-
metis
Idiomatic wrapper for METIS, the serial graph partitioner and fill-reducing matrix orderer
-
lambert_w
Fast and accurate evaluation of the Lambert W function by the method of T. Fukushima.
-
num-prime
Generic and optimized primality test, factorization and various number theoretic functions with arbitrary precision based on
num
-
rsparse
solving sparse linear systems using direct methods
-
icao-wgs84
performing geometric calculations on the WGS84 ellipsoid
-
mathru
Fundamental algorithms for scientific computing in Rust
-
distrs
PDF, CDF, and percent-point/quantile functions for the normal and Student’s t distributions
-
krnl
Safe, portable, high performance compute (GPGPU) kernels
-
laddu
Amplitude analysis made short and sweet
-
rust_ti
An advanced and configurable technical indicators library with over 70 unique indicators for stock market technical analysis
-
malachite
Arbitrary-precision arithmetic, with efficient algorithms partially derived from GMP and FLINT
-
petal-decomposition
Matrix decomposition algorithms including PCA (principal component analysis) and ICA (independent component analysis)
-
number-general
A generic number type for Rust which supports basic math and (de)serialization
-
concrete-ntt
pure Rust high performance number theoretic transform library
-
parry3d
3 dimensional collision detection library in Rust
-
stacked_linear_algebra_graph
Embedded in-memory graph using sparse linear algebra
-
rlst
native linear algebra library
-
arpfloat
Arbitrary-precision floating point library
-
zeromq-src
Source code and logic to build ZeroMQ from source
-
s2
S2 geometric library
-
process_mining
Process Mining library for working with (object-centric) event data
-
series
Laurent series in a single variable
-
polynomial_subspaces
general ways to deal with subspaces of the polynomial rings R[X] with R some ring
-
boostvoronoi
Boost voronoi ported to 100% rust
-
fj-interop
Early-stage b-rep CAD kernel
-
numbat
A statically typed programming language for scientific computations with first class support for physical dimensions and units
-
kalker
A calculator that supports user-defined functions, variables and units, and can handle fairly ambiguous syntax
-
boolean_function
Mathematical analysis of Boolean functions
-
csc
Command Line Scientific Calculator
-
rink
Unit conversion tool, similar to frink
-
mahc
cli riichi mahjong calculator, which spits out yaku and fu for a given hand
-
figures
A math library specialized for 2d screen graphics
-
arithmetic-parser
Parser for arithmetic expressions with flexible literals and type annotations
-
intel-mkl-src
Redistribution of Intel(R) MKL as a crate
-
autodj
Automatic Differentiation Library
-
diffsol
solving ordinary differential equations (ODEs) in Rust
-
yamlscript
Program in YAML — Code is Data
-
stats-ci
A pure Rust library for computing and working with confidence intervals on sample data
-
nalgebra-spacetime
Spacetime Extension for nalgebra
-
geo-aid
designed to generate geometrical figures based on given rules
-
feldera_rust_decimal
Decimal number implementation written in pure Rust suitable for financial and fixed-precision calculations
-
strict-num
A collection of bounded numeric types
-
reso
visual pixel-art logic-circuit design language
-
cnfgen
Generate DIMACS CNF formula from operations
-
polynomial
manipulating polynomials
-
mosek
Rust API for MOSEK optimization tools
-
multicalc
Rust scientific computing for single and multi-variable calculus
-
calc_rational
CLI calculator for rational numbers
-
rooc
A modeling language to write and solve linear optimization models
-
polar
A command-line calculator that can also convert between units
-
ibig
A big integer library with good performance
-
hexing
A basic Rust library to manipulate hexagonal grids
-
pihex
Arbitrary place hexadecimal digits viewer of pi written in Rust
-
spdcalc
Spontaneous Parametric Downconversion Calculator
-
stv-rs
Single Transferable Vote implementation in Rust
-
ecolor
Color structs and color conversion utilities
-
phylodm
Efficient calculation of phylogenetic distance matrices
-
inari
interval arithmetic
-
string_calculator
A string calculator to compute formulas inside strings
-
fasteval
Fast evaluation of algebraic expressions
-
castep_model_generator_backend
A rust-written backend lib for edit and generation of lattice 3D-models compatible with CASTEP and Materials Studio
-
rpn-cli
Command line reverse polish notation calculator
-
amplify_num
Amplifying numeric types: big-sized and bit-sized integers
-
libfive
Tools for solid modeling, especially suited for parametric and procedural design
-
floccus
Formulae for air thermodynamic calculations
-
Sph2-rs
An improved version of Sph-rs, that uses a mod to calculate the desired values
-
kifmm
Kernel-independent fast multipole method
-
stochastic-rs
quant finance and simulating stochastic processes
-
piecewise_polynomial
Fitting and interpolation with piecewise polynomials
-
microgemm
General matrix multiplication with custom configuration in Rust. Supports no_std and no_alloc environments
-
f256
Octuple-precision floating-point arithmetic
-
scalarff
A minimal, opinionated, library for working with scalar finite fields
-
honeycomb-render
Visualization tool for combinatorial maps
-
standardform
Effortlessly operate on numbers like 2e19 or 2*10^4 and more with this Rust implementation of standard form. Simplify, convert, and manipulate large numerical expressions with ease.
-
scilib
A scientific library for the Rust programming language
-
pm-remez
Parks-McClellan Remez FIR design algorithm
-
rational
Minimalistic library for rational numbers
-
const-primes
Work with prime numbers in const contexts. Prime generation, primality testing, prime counting, and more.
-
moontool
John Walker's moontool.c astronomical calculation routines, extracted and ported to Rust
-
mappers
Pure Rust geographical projections library
-
angle-sc
performing accurate and efficient trigonometry calculations
-
graphblas_sparse_linear_algebra
Wrapper for SuiteSparse:GraphBLAS
-
libnoise
performant, and customizable procedural noise generation library
-
plane-split
Plane splitting
-
basic_dsp
Digital signal processing based on real or complex vectors in time or frequency domain
-
russell_stat
Statistics calculations and (engineering) probability distributions
-
spherical_geometry
A package for working with spherical geometry
-
null-kane
currency crate with the option to add your own currency localization logic
-
intervalsets
bounded and unbounded intervals implemented as sets with all the associated set operations
-
p3-dft
Discrete Fourier transforms
-
bare_metal_modulo
ModNum is a highly ergonomic modular arithmetic struct intended for no_std use
-
softfloat-wrapper
a safe wrapper of Berkeley SoftFloat based on softfloat-sys
-
cavalier_contours
2D polyline/shape library for offsetting, combining, etc
-
ring360
wrapper type for 64-bit floats representing degrees around a circle. It has operator overloads for addition and subtraction, calculates the shortest angles and implements the core trigonometric functions.
-
signal-transforms
A comprehensive Rust library for discrete and wavelet transforms, including DCT, Dct_2d, DWT2, and more
-
volute
Boolean functions implementation, represented as lookup tables (LUT) or sum-of-products (SOP)
-
ndarray-conv
N-Dimension convolution (with FFT) lib for ndarray
-
jakkunight-ali
CLI tool for matrix calculation
-
get-hash
Get hash of a string
-
newton_rootfinder
Newton based methods for root finding
-
augurs-outlier
Outlier detection for time series
-
dashu
set of big numbers
-
integrate
Small, lightweight Rust library for performing numerical integration
-
p3-matrix
Plonky3 Matrix APIs
-
avalog
An experimental implementation of Avatar Logic with a Prolog-like syntax
-
lean-sys
Bindings to Lean 4's C API
-
nauty-Traces-sys
Low-level bindings for nauty and Traces
-
lowdim
two- to four-dimensional integer geometry
-
vf2
VF2 subgraph isomorphism algorithm in Rust
-
creusot-contracts
contracts and logic helpers for Creusot
-
fpmath
A floating point math library
-
fastnum
Fast numbers library
-
gf2_192
Arithmetic operations and polynomial interpolation over Galois fields GF(2^192)
-
number-theory
Fast primality, factorization and elementary number theory for integer types
-
sphere-n-rs
N-Sphere Code Generation in Rust
-
irox-units
Physical Quantities, Units, & Reference Frames Library
-
flag-algebra
Razborov's flag algebras
-
bezier-rs
Computational geometry algorithms for Bézier segments and shapes useful in the context of 2D graphics
-
rs-math3d
Rust 3D Math (no dependency on std)
-
makepad-math
Makepad math functions
-
infinitable
Infinity for types without infinite values
-
RayBNN_Sparse
Sparse Matrix Library for GPUs, CPUs, and FPGAs via CUDA, OpenCL, and oneAPI
-
pid-lite
A small PID controller library
-
voxel-tiler-core
Convert point clouds to voxel data
-
temp-converter
terminal temperature unit converter between Celsius, Fahrenheit and Kelvin
-
taz
evaluate a mathematical expression
-
symbolica
A blazing fast computer algebra system
-
scad_tree
Generate OpenSCAD code from Rust
-
xensieve
Xenakis Sieve, providing a Sieve from a string expression that filters integer sequences into iterators of integers, Boolean states, or interval widths. Sieves are built from Residuals…
-
yagi
Batteries-included DSP library
-
matio-rs
Rust wrapper to MATLAB MAT file I/O library
-
bc
Use
bc
in the Rust Programming Language -
sum-calc
A sum calc
-
gendelbrot
A small, simplistic mandelbrot image generator
-
modcholesky
Modified Cholesky decompositions
-
ldpc-toolbox
aid in LDPC code design
-
ha-ndarray
A hardware-accelerated n-dimensional array
-
qsv-stats
Computing summary statistics on streams
-
eiche
tools for working with symbolic expressions
-
lair
Linear algebra in Rust
-
del-geo
2D/3D geometry utility codes
-
metallic
C math functions from scratch
-
irox
Tools & Libraries
-
skeid
a linear algebra library for game graphics and physics
-
ndarray-glm
Performs regression for generalized linear models using IRLS on data stored in arrays
-
hfs
Hereditarily finite sets
-
warmup
Calculates the repetitions required for a warmup
-
stochasta
stochastic analysis library
-
simul
discrete-event simulation library aimed at high-level use-cases to quickly simulate real-world problems and run simulated experiments. Some example use cases might include simulating logistics or operations research…
-
pathfinder_geometry
Basic SIMD-accelerated geometry/linear algebra
-
lazyivy
Lazy Runge-Kutta integration for initial value problems
-
schlandals
probabilistic inference by projected weighted model counting
-
git-topic-stage
Logic for managing a topic stage on top of a base branch in git
-
d3_delaunay_rs
A port of D3/d3-delauany
-
ogsolve
The program for solving octal games
-
kzg-rs
KZG point evaluation
-
vax-floating
VAX floating-point types
-
ruint2
Unsigned integer type with cont-generic bit length
-
eng-units
Engineering unit coversions and calculations
-
collatz_rust
Code for testing an extention of the Collatz Conjecture
-
al-jabr
An n-dimensional linear algebra library
-
aspect360
This builds on the Ring360 to calculate aspect matches from target angles with orbs or an array of target aspect/orb pairs
-
fixed_math
Some math traits and functions for
fixed
point numbers -
eqsolver
that solves equations using numerical methods
-
musclecalc
fitness: estimate the one repetition maximum (1RM)
-
rssat
that provides Rust bindings for multiple popular SAT solvers
-
calcifer-server
Backend logic for the Calcifer project
-
green-kernels
Evaluation of Green's function kernels
-
oxidd
A safe, concurrent, modular, and performant decision diagram framework
-
strain
A CPU stressing utility written in Rust
-
specialized-div-rem
specialized division algorithms for integer primitives
-
graphics-shapes
Shapes for graphics
-
chemrust-nasl-app
New Adsorption Site Locator (NASL) for catalyst materials. Written in rust. Part of the
chemrust
toolchain. This is the binary crate. -
raa_tt
Proves sentences of propositional calculus
-
flavio
welcomes you
-
distimate
providing probability distributions for estimation and risk analysis
-
longitude
Work with real world coordinates in Rust!
-
softposit
Posit numbers
-
floco
validates floats against constraints
-
boolean-logic
propositional logic evaluator that creates truth tables for propositional expressions
-
impact-rs
Collision query library for 2D games
-
vector2math
Traits for doing 2D vector geometry operations using standard types
-
calc
CLI calculator app
-
ndarray_einsum_beta
einsum function for the Rust ndarray crate. As popularized in numpy, einsum (Einstein summation) implements general multidimensional tensor contraction. Many linear algebra operations…
-
truck-modeling
integrated modeling algorithms by geometry and topology
-
break-eternity
A numerical library to represent numbers as large as 10^^1e308 and as 'small' as 10^-(10^^1e308)
-
mdarray
Multidimensional array for Rust
-
nexsys
Solve nonlinear systems of equations using Newton's method
-
rust-blas
BLAS bindings and wrappers, fork of rblas
-
dimensionals
Rust native generic, flexible n-dimensional array
-
pvz_interception_calculator
rewrite of the original PVZ Interception Calculator that calculates precise imp movement
-
csvbinmatrix
Binary matrix Compressed Sparse Vector
-
dual_balanced_ternary
Dual Balanced Ternary Arithmetic
-
oat_python
User-friendly tools for applied topology in Python
-
opengm_rts
GM/T 0005-2021 randomness test suits written in Rust
-
ffactor
A very minimal number theory utilities
-
dendritic-metrics
Metrics package for dendritic
-
polyfit-residuals
Efficiently calculate the residual errors (in the least squares sense) of all polynomial models (up to some degree) for a given dataset and compute least-squares polynomial fits
-
ml-distance
Distance-based methods for vector comparison and analysis. (Porting of the JS/TS pkg
ml-distance
to Rust) -
rust-poly
Numeric manipulation of real and complex polynomials
-
csta
A personal statistics library
-
daisycalc
A high-precision terminal scientific calculator
-
komodo
cryptographically-proven erasure coding for distributed systems
-
hpn
Text-based RPN-style calculator in the HP Voyager tradition
-
qhull
Rust bindings to Qhull
-
inovo-rs
API for intergrating inovo robot arm
-
mate-rs
lightweight arithmetic expression interpreter
-
vom_rs
Probabilistic Finite Automata
-
mcdm
assist with solving Multiple-Criteria Decision Making (MCDM) problems
-
schnapsen-rs
Schnapsen implementation in Rust
-
math_repl
REPL for all different kinds of math
-
fj
Early-stage b-rep CAD kernel
-
zk-citadel
Citadel, a SSI system integrated in Dusk Network
-
finitelib
advanced maths over finite groups, fields, their extensions, multi precision operations, euclidean rings, polynomials and related things
-
pitch-pipe
Pitch Pipe is a method for automatically tuning a one euro filter
-
dana
Compile-time dimensional analysis via generic types
-
algexenotation
in Rust
-
aglet
Opinionated integer-based coordinates and directions and utilities
-
baa
BitVector and Array Arithmetic
-
noise-algebra
Easy manipulation of noise functions
-
fitme
CLI curve fitting tool. Parameterise an equation from a CSV dataset.
-
cfsem
Quasi-steady electromagnetics including filamentized approximations, Biot-Savart, and Grad-Shafranov
-
discrete-gaussian
Gaussian sampling over discrete fields/rings/sets
-
eca
A cli tool to run elementary cellular automatons
-
RustQuant_ml
quantitative finance
-
seismic-response
Seismic response analysis of a single particle system is performed using Newmark's beta method
-
gemm
Playground for matrix multiplication algorithms
-
nice_and_easy
A minimalistic Rust library for smooth and effortless easing functions
-
floating-ui-core
Rust port of Floating UI. Positioning library for floating elements: tooltips, popovers, dropdowns, and more.
-
rust_ev_system_library
E-Voting system library functionalities for the Verifier
-
RayBNN_DiffEq
Matrix Differential Equation Solver using GPUs, CPUs, and FPGAs via CUDA, OpenCL, and oneAPI
-
static-math
Fast mathematical operations with static arrays, without
unsafe
code -
espada
Texas Hold'em poker odds evaluator
-
algori
Rust Algorithms
-
csd-rs
Canonical Signed Digit Conversion in Rust
-
rstm
focuses on building concrete implementations for Turing Machines
-
ohsl
A collection of numerical routines and mathematical types for use in scientific computing
-
dace
Rust wrapper of DACE, the Differential Algebra Computational Toolbox
-
root1d
One dimensional root finding algorithms
-
doubled
Dekker arithmetic
-
erydanos
Optimized routines for ARM NEON and SSE
-
ratio-graph
Ratio's graph manipulation library
-
kalman-rust
Dead simple implementation of Discrete Kalman filter for object tracking purposes
-
rfcalc
calculate things
-
od_opencv
Object detection utilities in Rust programming language for YOLO-based neural networks in OpenCV ecosystem
-
kalkulator
A mathematical expression evaluation tool and library
-
br-maths
maths
-
tiny-solver
Factor graph solver
-
glar-gemm-c32
high performance cpu kernels
-
shape-core
Definition of geometry shapes
-
patch-tracker
Patch tracker
-
divert
Rust Lang bindings for Recast Navigation
-
acme
Acme aims to provide a solid foundation for developing robust machine-learning systems in Rust
-
ndarray-interp
Interpolation package for ndarray
-
bempp
Boundary element method library
-
fuzzy-logic_rs
fuzzy logic in rust!
-
qdk_sim_rs
Rust-based simulators for use with the Quantum Development Kit
-
is_prime
Fast arbitrary length prime number checker using the Miller-Rabin primality test algorithm
-
quaigh
Logic optimization library
-
ndhistogram
multi-dimensional histogramming for Rust
-
qvnt
Advanced quantum computation simulator
-
openchecks
checks framework
-
kapacitor-multi-indicator-batch-udf
A multi-indicator batch UDF for Kapacitor
-
rxcalc
An expression calculator, originally written in Scratch
-
twibint
arithmetic on arbitrarily large integers. Provides Python bindings as well.
-
std-traits
Traits for types in the standard library
-
rootfinder
Root-finding methods for both univariate, scalar-valued functions and multivariate, vector-valued functions
-
integrator
A math library
-
bempp-octree
create Octrees
-
langtons-termite
Langton's Ant that runs in a terminal window
-
noether
Abstract algebraic structures for Rust
-
ariprog
Need a powerful and simple library to work with arithmetic progressions in Rust? You should definitively try out ariprog!
-
break_infinity
larger numbers up to 1e9e15 in Rust for Incremental Games
-
chfft
Fastest Fourier Transform library implemented with pure Rust
-
albert
A terminal calculator written in Rust with ❤️
-
lib_rapid
LibRapid - a library specifically built for mathematical calculations and scientific applications
-
prime-factor
A prime number factorizer written in Rust
-
lambdaworks-gpu
Modular math library for cryptography - GPU implementation
-
gaussian_curve_fit
A no_std and no heap memory library for gaussian curve coefficents calculation
-
rsmonad
Haskell-style monads for idiomatic Rust
-
nml-matrix
A small library to work with matrices
-
zfc
Trait that represents a set according to Zermelo–Fraenkel set theory with the axiom of choice (ZFC)
-
p3-commit
Plonky3 APIs relating to commitments
-
complex-bessel-rs
compute Bessel functions
-
rapier3d-f64
3-dimensional physics engine in Rust
-
ga2
Common types for 2D geometric algebra
-
faer-ext
faer-rs API for interoperability with external libraries
-
quad_gk
Pure rust numerical integration library based on Gauss Kronrod quadrature rule
-
rspp
rust probolistic programming
-
vec3-rs
3D vector math library
-
cgt
Combinatorial Game Theory framework
-
rmatrix_ks
matrix and some algebra in Rust
-
signal-gen-cjds66-lib
An unofficial support library which can fully remote control the inexpensive Koolertron DDS Signal Generator known as GH-CJDS66
-
kn0syseccrs
Intuitive library for elliptic curve cryptography tutorials
-
event-sourcing
Event sourcing made ease!
-
chrom
representing colours
-
curve-sampling
Adaptive sampling of parametric
-
vector_operations
A collection of vector operations for Rust
-
rusty-talib
using pure rust code for technical analysis
-
aberth
Aberth's method for finding the zeros of a polynomial
-
capy-graph
A framework for constructing arithmetic circuits on-the-fly
-
automesh
Automatic mesh generation
-
proj5
Pure Rust, type-safe alternative to PROJ.4
-
int_ratio
The type of ratios represented by two integers
-
distributed_control
Create, analyze and simulate multi-agent, distributed control systems
-
pawer_core
doc Calculus of Construction
-
sickle_math
Math dependencies for sickle_ui
-
rust-gd
Generalized Deduplication based on Error-Correcting Codes
-
gcdx
Calculate the greatest common divisor of multiple values
-
realistic
Towards an API for the Real Numbers
-
opensrdk-probability
Standard probability library for OpenSRDK toolchain
-
stcalc
Stack calculator
-
carlo
interpreted programming language
-
all-is-cubes-base
Helper library for all-is-cubes. Do not use directly.
-
divrem
Division and modulus variants
-
rusty_math
mathematical, statistical and machine learning operations
-
wkb-rs
Conversions between WKB (Well Known Binary) and geo-types
-
fixed_trigonometry
Fixed point numerical approimations to trigonometric functions
-
logic-form
representing Cube, Clause, CNF and DNF
-
ffnt
Finite fields for number theory
-
collider
continuous 2D collision detection for game developement
-
rmathlib
Port of R's C Library of Special Functions
-
alemat
type-safe building of MathML
-
compute-tau
designed for computing tau to millions of digits
-
meshless_voronoi
Meshless Voronoi algorithm
-
errorfunctions
Pure Rust package to compute the error function, Dawson's function, and Faddeeva's function for real and complex arguments
-
prime_factorization
Prime factorization up to 128 bit integers
-
fidget_math
glam vector types for tree construction with fidget
-
cubes
Applications for determining how to put a cube together
-
num-runtime-fmt
Format numbers according to a format spec determined at runtime
-
abstalg
Abstract algebraic structures for Rust
-
polynomial-over-finite-prime-field
polynomial over finite prime field
-
vecmat
Low-dimensional vector algebra with min_const_generics support
-
gali
untyped lambda caluculus, with some sugar for convenience
-
damndiff
Numerical methods for ODE
-
unit-sphere
performing geometric calculations on the surface of a sphere
-
centerline
finding centerlines of 2D closed geometry
-
instant-glicko-2
Glicko-2 rating system that allows for instant feedback after games, not just once a rating period closes
-
mathio
A lightweight, simple and straight-forward opinionated library for math used in other projects
-
zero-plonk
A pure-Rust implementation of the PLONK ZK-Proof algorithm
-
butterworth
filters
-
vectrix
A stack-allocated matrix type implemented with const generics
-
basic_dsp_vector
Digital signal processing based on real or complex vectors in time or frequency domain
-
elementary-cellular-automaton
that handles Elementary Cellular Automata
-
delaunay_creator
delaunay triangulation for 2D and 3D(not implemented yet)
-
ring-math
Polynomial ring math over scalar finite fields
-
amortize-rs
A loan amortization calculator library
-
crate_crypto_internal_eth_kzg_polynomial
methods that are needed for Polynomial objects
-
dexterior
Discrete Exterior Calculus toolkit
-
area_crate
Basic Area function
-
entropyscan-rs
File entropy scanner to detect malware
-
rotary-add
adds a few simple methods to the three lowest unsigned integer types, u8, u16 and u32 to allow cyclical addition and subtraction around the same 0 to (limit - 1) range or from 1 to a limit
-
rustgf
implements several galois field operation in Rust, as well as gaussian elimination in Galois Field
-
geo-aid-plaintext
Support for plaintext output from Geo-AID
-
rust_solar
Date-time solutions for hypothetical cosmic calendars
-
kahan_pairs
Generate pairs of integers
-
uniform-cubic-splines
uniform cubic spline evaluation and inversion
-
tabularlib
Small library for abstract matrices stored in single linear vectors created as practice project
-
pythagorean-hodographs
Pythaogrean hodograph splines
-
numbat-cli
A statically typed programming language for scientific computations with first class support for physical dimensions and units
-
fixed-bigint
Fixed-size big integer implementation for Rust
-
moyo
Crystal Symmetry in Rust
-
strmath
Do math with your strings
-
ndgrid
n-dimensional grid library
-
lambda-types
Puts the lambda calculus in Rust...'s type system
-
smolmatrix
Small simple matrix library
-
aviation_calc_util
assist with aviation related calculations
-
linearalgebra
Test project to learn Rust and implement a small library for linear algebra
-
polygon-offsetting
polygon offsetting crate
-
algebra_kit
An abstract algebra library for Rust
-
microlp
A fast linear programming solver library
-
amalie
Mathmatical library written for rust and python
-
malachite-q
The arbitrary-precision type Rational, with efficient algorithms partially derived from GMP and FLINT
-
overworld
Metapackage library for adding game systems useful for incremental, RPG, and management games
-
irox-fixedmath
Fixed Precision Math Primitives
-
beetle-fraction
functions & structs for doing math with fractions
-
quaternion-wrapper
Operator overloading allows implementation similar to mathematical expressions
-
circle
Definition of circle and ellipse
-
mangle-ast
Mangle, a logic programming language
-
bsd4random
4.4BSD random number generator
-
sauss-cramer
es una librería que ayuda a resolver sistemas 2x2 y 3x3 de ecuaciones lineales, usando el método de reducción de Crammer
-
bigraph
Different representations with implemented operations on bigraphs
-
amonoid
A general-purpose monoid library
-
hexagon_tiles
that allows working with the hexagon shape and related math
-
kata_machine
A quick way to generate a sandbox, start coding and easily test your katas across multiple languages
-
quad-rs
Adaptive Gauss-Kronrod Integration in Rust
-
lnexp
Carefully evaluate compositions of log, exp, log1p and expm1
-
decimal-percentage
Percentage type with rust_decimal
-
katex
Rust bindings to KaTeX
-
mutils
Mathematical-like utilities. Points, Sizes, Colours, maths operating on them. Things like that.
-
simple_accumulator
accumulator for incremental statistical computations
-
numerical-linear-algebra
linear algebra implemented using numerical methods
-
ilog
Base 10 and 2 logarithm functions for integer types
-
auto_regressive
constructing AR(p) models using the Yule-Walker equations
-
big_num_math
computations on large numbers
-
i_shape_js
Boolean Operations for 2D Polygons. Supported operations: intersection, union, difference, XOR, and self-intersections for all polygon varieties.
-
dicoco_safe_math
simplified safe math operations
-
parry2d
2 dimensional collision detection library in Rust
-
yices2
Rust bindings to the Yices 2 SMT solver
-
gmp-mpfr-sys
Rust FFI bindings for GMP, MPFR and MPC
-
roundable
Round numbers and durations to a given factor
-
sophus_lie
sophus - geometry for robotics and computer vision
-
blas
The package provides wrappers for BLAS (Fortran)
-
option-operations
Traits and auto-implementations to improve arithmetic operations usability when dealing with
Option
s -
geo_filters
Geometric filters for set cardinality estimation
-
supply-chain-trust-example-crate-000033
Numeric traits for generic mathematics
-
hundred-doors
calculating and visualizing the '100 Doors' problem
-
opensrdk-linear-algebra
Standard linear algebra library using blas and lapack for OpenSRDK toolchain
-
sundials-sys
Bindings to the SUNDIALS suite of Nonlinear and DAE Solvers
-
equation
mathematical expression evaluation and simplification
-
xmath
Rust port of Microsoft DirectXMath
-
clausen
functions
-
rust-github-action-test-b76u22ivt4z3
四則演算を行うライブラリ
-
radix-rect
Rust port of Radix Core Rect
-
filon
Highly oscillatory quadrature in Rust
-
min_max_assign
Change min(max) implementation in Rust
-
sonnenbrille
8-bit CRC
-
hello_cargo_lulu
cargo publish test
-
ggblas
Matrix multiplicatiosn in simple pure rust multithreadded blas-like interface. Exploits intrinsics on available targets
-
proto-vulcan
A miniKanren-family relational logic programming language embedded in Rust
-
number-diff
number-based is an attempt of mine to make working with calculus easier
-
spin4
esoteric programming language that uses 4D rotations for computations
-
heapless_matrix
efficient implementation of a matrix data structure in Rust. It offers functionality for creating, manipulating, and performing operations on matrices, such as transposition, summation, and multiplication.
-
convolution-dsp
1-dimensional convolution library intended for use in DSP applications
-
truck-topology
topological structs: vertex, edge, wire, face, shell, and solid
-
faasle
evaluating distances (metrics)
-
hilbert_2d
Functions for mapping between 1D and 2D space using the Hilbert curve, and its approximations
-
integral_lib
liblary for solving integrals using numerical methods
-
fffft
Number theoretic transform for PrimeField types (from ff crate)
-
sundials
Suite of nonlinear and differential/algebraic equation solvers
-
inrust
Accumulate knowledge of my study on Rust language
-
graphembed
graph embedding
-
aprilgrid
Aprilgrid
-
vctr2
2d vector library
-
cork
A command-line calculator for hex-lovers
-
meansd
calculate mean and standard deviation
-
simple_colatz
package to compute the colatz conjecture in rust
-
aegir
Strongly-typed, reverse-mode autodiff library in Rust
-
nalgebra-sparse
Sparse matrix computation based on nalgebra
-
jingle
SMT Modeling for Ghidra's PCODE
-
signum-sign
Adds the signum function to Rust
-
net_promoter_score
calculating Net Promoter Score (NPS) from survey responses
-
codemonk-primes-cli
A command-line utility for finding prime numbers
-
libprimesieve
Access to the C function primesieve_generate_primes
-
supply-chain-trust-example-crate-000074
Integer traits and functions
-
cga2d
2D Conformal Geometric Algebra primitives
-
fwd_ad
Forward auto-differentiation, allowing its user to manage memory location and minimize copying
-
aga8
GERG2008 equations of state
-
zzz_lib
a test crates
-
yttria
that re-exports the other yttria sub-libraries for radio application development
-
allan-tools
Package to compute statistics to study systems stability
-
my3
My3
-
lowbulls
lowbull is a Rust crate facilitating message handling and event monitoring
-
num-ordinal
Ordinal number types
-
nalgebra_latex
several robust formatters for nalgebra::Matrix, LaTeX environments, and more
-
ihateintegrals
A computer algebra library for solving integrals
-
vector-space
Useful traits for working with vector spaces
-
nabo
A fast K Nearest Neighbor (KNN) library for low-dimensional spaces
-
scuttle
A multi-objective MaxSAT solver
-
minifb_geometry
meant to help draw shapes in the minifb window
-
quadratic_residues
calculating quadratic residues of integers
-
wedged
A robust and generalized library for Geometric Algebra in Rust
-
amd
Approximate Minimum Degree ordering
-
gemm-benchmark
BLAS [sd]gemm benchmark
-
mazer-core
A minimal, simple math markup language that compiles to HTML, written in Rust
-
utils-box
A toolbox of various small RUST utilities that make our lifes easier
-
math-kit
Math Library for Rust 🦀
-
aig
Rust Aig library
-
maths-traits
abstract system of mathematical traits for the Rust language
-
boomerang_runtime
Runtime types and discrete event executor for Boomerang
-
extra-math
Accidentally published
-
ancomplex
Package provides easy to use, begginer frendly and python like complex numbers
-
sr-rcd
Apply Refining-Cover-by-Defect algorithm to solve Sound Ranging problem in time-dependent-metric (and, in particular, (quasi-)metric) spaces
-
remsol
Electromagnetic mode solver for 1D multilayer structures
-
egml-io
IO operations for processing GML data
-
angle
wrapper to avoid ambiguous parameters + common operation over angles like wrapping, comparisons, arithmetic operations, trigonometric operations and conversions between rad and deg
-
ramp
A high-performance multiple-precision arithmetic library
-
gmres
A sparse linear system solver using the GMRES iterative method
-
prime-checker
hold sample functions to check the prime-ness of a given unsigned, 64-bit integer
-
my_parser_kma_test_group_3_1_Hordashko
A brief description
-
substrate-fixed
Fixed-point numbers
-
gkquad
Numerical integration library for Rust
-
mathcalculate
My first Rust library
-
vectora
A vector computation library
-
dendritic-bayes
Package for doing baysian statistics
-
find_peaks
Find peaks that match criteria in 1D data
-
calc_mjp
calc simple library
-
mathjax_svg
Convert mathematical expressions to SVG using Mathjax
-
butter2d
Butterworth filter for image processing
-
rustsat-tools
Tools and examples built on the RustSAT library
-
gemau
The beginnings of a computer algebra system for Combinatorial Game Theory
-
core_maths
Extension trait for full float functionality in
#[no_std]
backed bylibm
-
ravencol
Tabular data manipulation
-
matrix_lib
easy to use library to operate on matrices
-
lp_parser_rs
parser for the LP file format
-
metamath-rs
manipulating Metamath databases, including a parallel and incremental verifier for Metamath databases
-
autopp_inc
example package
-
xer_adder
Example crate with a dependency
-
bog
The highly-modular abstraction standard
-
rcgal
Rust Computational Geometry Algorithms Library
-
rug-maths
rug wrapper implementing maths-traits
-
mini-matrix
A mini linear algebra library implemented in Rust
-
nauty-pet
Canonical graph labelling using nauty/Traces and petgraph
-
maths_function
Some maths fuctions
-
del-geo-nalgebra
2D/3D geometry utility codes
-
hangman_solver
Solves hangman puzzles
-
fitting
Pure Rust curve fitting library
-
spawn-stochastic
simulating multiple stochastic processes including ABM, GBM, Ornstein-Uhlenbeck, Feller Square Root, and Brownian Bridge
-
emesh
processing 3D polygon meshes
-
malachite-base
A collection of utilities, including new arithmetic traits and iterators that generate all values of a type
-
boolean_expression
manipulating and evaluating Boolean expressions and BDDs
-
tiny-vo
Patch tracker
-
rpn-c
A calculator environment using Reverse Polish Notation and multiple precision numbers
-
cubecl-common
Common crate for CubeCL
-
rene
Computational geometry
-
ibdl-extractors
Imageboard post extractors used in imageboard_downloader
-
lina
Linear algebra library with a focus on 3D applications like games (i.e. low-dimensional vectors and matrices)
-
sparsetools
2-D sparse matrix package for numeric data
-
takeable-option
A small wrapper around option
-
vector-victor
linear algebra crate
-
gardenerpersonal-rustpkg
that adds numbers
-
gecl
geometry types and a color type
-
hercules
A Heuristics toolbox for QUBO in Rust
-
rust-GSL
binding for the GSL (the GNU scientific library)
-
ff_k_center
A linear-time k-center algorithm with fairness conditions and worst-case guarantees that is very fast in practice. Includes python bindings.
-
stat-rs
A statistics library
-
ecm
Lenstra's Elliptic Curve Factorization Implementation with Big Integers
-
lll-rs
LLL algorithm for lattice reduction and it's improved version L²
-
talrost
A mathematics library for embedded scientific computation
-
vector3
dealing with 3D mathematical vectors
-
noir-bignum-paramgen
command line tool to convert a modulus into bignum instance parameters for https://github.com/noir-lang/noir-bignum
-
libpcp
A constraint solver supporting arithmetic constraints over integers
-
xdbuf
reusable multi-dimensional buffer
-
rapl
that makes numerical scripting with Rust simple and enjoyable
-
mini-math
Lightweight math routines for 3D graphics
-
geogebra-types
Geogebra types and API for building them
-
gut
Geometry utilities: storing, manipulating and processing geometries
-
math-shop
mathematical tools in pure Rust
-
microcheby
Single variable function approximation using Chebyshev polynomials. Embedded friendly and no_std compatible.
-
nums
Number theoretic functions, such as primality testing and factorization, for BigUints
-
intervals
A generic interval type with support for open/closed bounds
-
costoflife
The CostOf.Life Calculator
-
glar-gemm-f64
high performance cpu kernels
-
ca4rs
Cellular Automata for Rust
-
array-bin-ops
Efficient array binary operations
-
poe-superfilter
Extended syntax compiler for Path of Exile loot filters
-
sylvan-sys
Bindings for the Sylvan parallel decision diagrams library
-
guff-matrix
Fast Galois Field matrix multiplication
-
accelerate-general
A general matrix and vector operations library using Apple's Accelerate framework
-
new_york_utils
calculation some things
-
zonne
Mr.Z's Rust Open Source Library
-
non0
Compile-time checked non-zero integers with type inference and first-class
const
support -
ndarray-inverse
Pure Rust Inverse and Determinant trait for ndarray Array2
-
extended_matrix
A matrix calculation module
-
permanganate
Graph and Boolean SAT solver for Numberlink and Flow Free
-
rustitude
create and operate models for particle physics amplitude analyses
-
slist
Algebraic lists with statically determined size that live on stack
-
bounds
interact with bounded and unbounded ranges
-
hasty
interface to system BLAS libraries for fast linear algebra operations
-
polymath
Make math in Rust more powerful! (New math datatypes, traits, functions, etc...)
-
minimax-alpha-beta
Alpha-Beta Pruning + Minimax Algorithm for arbitrary two player minimax style games like Chess, Go, TicTacToe, etc
-
super_ultra_rpn_calc
RPN(Reverse Polish Notatio) library
-
p3-mersenne-31
Mersenne31 field implementation for Plonky3
-
sfink_callgraph_traversal
Experimental callgraph traversal/analysis tool, currently limited to loading an internal format produced by a static analysis
-
hmath
Big Integers and Rational Numbers
-
hmmmm
Performant and easy-to-use hidden Markov models
-
fibs
Get a Fibonacci number or sequence
-
sampling
Large-deviation Algorithms like Wang-Landau, Entropic sampling, Replica-Exchange Wang-Landau, Heatmaps, Histograms and bootstrap resampling. This is intended for scientific simulations
-
minvect
A mini vector library
-
ring-algorithm
algorithms on ring (Abstruct Algebra)
-
robust-predicates
Robust predicates for computer geometry
-
query-curve
querying custom Bezier curves, compatible with curves created at https://querycurve.com
-
zkp-primefield
A 251-bit prime field suitable for FFTs
-
RustGraphix
Rust-Graphix is a Rust library for mathematics. It includes support for matrices, both two-dimensional and three-dimensional, along with various matrix operations and methods.
-
liealg
lie group and lie algebra in rust
-
shapers
fitting shapes and operations on geometrical objects
-
arithmetic-typing
Hindley-Milner type inference for arithmetic expressions
-
rust-test-crate-add
Test rust package
-
gamesman-nova
System for computing the solution set of finite, deterministic, complete-information, abstract-strategy games
-
a_add_b
这是一个两数相加的方法
-
nibbler
A small utility for working with nibbles (half byte, 4-bits)
-
cenv_core
The internals for the cenv project, designed to be shared amongst different implementations
-
polycal
methods for fitting and using polynomial calibration functions following ISO/TS 28038
-
matrijs
A small 2D matrix library. There are many like it but this one is mine.
-
geos-src
static library build for geos-sys
-
malachite-nz
The bignum types Natural and Integer, with efficient algorithms partially derived from GMP and FLINT
-
un_algebra
implementations of selected abstract algebraic structures--including groups, rings, and fields. Intended for self-study of abstract algebra concepts and not for production use.
-
smartcalc
Text based calculator for peoples
-
gfxmath-vec2
2D math library
-
fast_fp
Floating point fast-math optimizations
-
fibext
A versatile Fibonacci sequence generator for Rust, with support for large numbers and optional iterator interface
-
RustQuant_stochastics
quantitative finance
-
ashlang
A language for zero knowledge proofs
-
lanczos
algorithm for eigen decomposition
-
unicode-math-class
Determine the Unicode class of a mathematical character
-
mematrica
An easy to use library for working with matrices
-
lamcal
A lambda calculus parser and interpreter
-
srmfpa
Floating-point's four arithmetic operations (including fused multiply-add) and square root with strict rounding mode
-
multi-skill
Skill estimation systems for multiplayer competitions
-
envisim_utils
methods for design-based sampling methods and estimation
-
basemath
math, from the ground up
-
poseidon-parameters
Poseidon parameters
-
haxcel
Excel gateway to Haskell
-
alum
Halfedge based polygon mesh library
-
corner-calculator
Command line utility and lib to calculate new x+y coordinates for a window for a certain direction (=numpad key) based on existing based on given screen and window dimensions
-
projgeom-rs
Projective Geometry in Rust
-
resolver
Expression evaluator
-
bens_number_theory
A sample Rust project for number theory stuff (I'm using this to learn Rust)
-
radians
storing angles
-
reductionist
S3 Active Storage server
-
herta-lib
Backend library for herta-bin
-
chime
WIP library for continuous, predictable, mutable change over time
-
lk_math
Common mathematical tools
-
kernel-density-estimation
Kernel density estimation in Rust
-
fj-math
Early-stage b-rep CAD kernel
-
r2rs-nmath
Statistics programming for Rust based on R's nmath package
-
koto_geometry
A Koto library with basic geometry types and operations
-
categorical
combining categorical random distributions and computing exact probabilities
-
dxpr
Differentiable expression templates in compile-time, dependency-free, no_std Rust
-
truth-values
Generate all possible combinations of N bools
-
triton-constraint-circuit
AIR constraints build helper for Triton VM
-
large-primes
Package for Large Prime Number Analysis
-
cellular_raza-building-blocks
cellular_raza Building Blocks
-
talna
WIP
-
iseven_api
wrapper for isEven API
-
solar
package
-
spral
Rust wrapper for SPRAL
-
lav
Lane-Associated Vector (LAV): Portable SIMD vector trait as GAT of SIMD lane trait
-
unit-interval
Types for working with and constraining values to the unit interval
-
fenris-geometry
Geometry functionality for fenris
-
irox-unsafe
irox (unsafe) Rust Tools & Libraries
-
dashu-float
A big float library supporting arbitrary precision, arbitrary base and arbitrary rounding mode
-
kissunits
Different units (like distances or coordinates), keeping it small and simple
-
snark-verifier
Generic (S)NARK verifier for Rust, halo2, and EVM. This is a fork of PSE's version.
-
thin-shunting
evaluating math expressions
-
algebra
Abstract algebra for Rust
-
mice
messing with dice
-
ndelement
n-dimensional finite element definition library
-
ratio-matrix
Ratio's matrix data library
-
codd
minimal in-memory database with relational algebraic expressions as queries
-
intfinity
An abstraction over numeric types with infinity implemented
-
jpegxl-src
Source of libjxl and logic to build it
-
fftw
safe wrapper of FFTW3
-
savage
A primitive computer algebra system (REPL)
-
fem_2d
2D Finite Element Method Toolkit
-
normdecimal
Always normal decimal numbers
-
poly_it
A no-std library for manipulating polynomials with slice support and minimal allocation
-
xdd
Decision diagrams including BDD, ZDD, MBDD, πDD and more for combinatorics
-
primal
primal
puts raw power into prime numbers. This crates includes: optimised prime sieves, checking for primality, enumerating primes, factorising numbers, and state-of-the-art estimation of upper and… -
fractions-rs
Fractions numbers implementation for Rust
-
ulam
calculations
-
rustmacaroon
A more rusty implementation of Macaroons
-
money2
For storing and asynchronously converting between (a subset of) ISO-4217 currencies
-
bs_crate
The palindrome numbers library
-
sprs-superlu
The package provides a high level interface between SuperLU, sprs and ndarray
-
cyclotomic
high-performance library for exact operations in cyclotomic fields
-
compute-pi
designed for computing pi to millions of digits
-
linal
tiny linear algebra library without dependencies
-
vec-utilities
A collection of methods that make working with Vecs of floats easier
-
interpolation
A library for interpolation
-
lapack-src
The package provides a LAPACK source of choice
-
m_calc
calculate math expressions
-
modular_equations
Program to solve quadratic and linear modular equations
-
decnumber-sys
Low-level bindings for libdecnumber
-
bsplines
N-dimensional B-spline curves and their derivatives built on top of nalgebra
-
snowflake_uid
A module for generating guaranteed unique IDs among a cluster of nodes using Snowflake logic
-
arranged
Statically bounds-checked (machine-word-abstracting? TBD) ranged types as zero or low-runtime overhead abstractions providing safe (no unintentional overflow) arithmetic
-
divisor_networks
Discrete Graphs for Indiscrete Researchers - Networks with Grothendieck Topology
-
llml
basic math data types with high level frontend and low level backend
-
parametrics
working with parametric functions
-
simple_vector2
libary for generic vector manipulation that just works
-
lox-math
Mathematical utilities for the Lox ecosystem
-
yali
LargeInt Library
-
quantogram
Approximate quantiles using histograms with logarithmically sized bins to guarantee worst case absolute relative error
-
slice2d
Ergonomic array slice for 2d array manipulation
-
upload_to_crate_io
Review Upload
-
yash-arith
POSIX shell arithmetic expansion
-
simp_linalg
A generically defined, light-weight linear algebra library for simple addition and multiplication of vectors and matrices
-
qrotate
Quaternion library for 3D rotation of vectors
-
complex-number
A basic implementation of complex numbers in rust
-
g_2_0_0
manipulate arbitrary object in the geometric algebra containing two perpendicular vectors that square to 1. Basically 2d VGA
-
neapolitan
Easily model and solve circuit-like problems
-
polyhedron-faces
polyhedron faces for Rust
-
mathpak
Rust Math Routines, a simple to use math focused library written in rust
-
subscript
reserved 👉 for the new compiler (and other infrastructure) see https://github.com/subscript-publishing 👉 We decided to move away from the old monolithic codebase and split everything…
-
acid2
2-adic double-precision floating-point implementation
-
tindex
Vec
, slice and bitset with custom index types -
structural-shapes
Common structural shapes
-
mpmfnum
A numbers library in Rust
-
yttria-coding
A mathematical coding library tailored for use with the yttria set of libraries
-
smooth-numbers
Algorithms to generate smooth numbers
-
sharpened_bilinear
Sharp bilinear image resizing in linear color space with premultiplied alpha
-
plotters-fullerene
plotters fullerene and polyhedron for Rust
-
memocalc
A useful tool for practicing mental mathematics
-
iltcme
Inverse Laplace transform with concentrated matrix-exponential functions
-
net_ensembles
Erdős-Rényi and small world ensembles. For simple sampling, Markov chains etc.
-
num-iter
External iterators for generic mathematics
-
autd3-geometry-viewer
AUTD viewer for Geometry
-
rlfsc
A checker for the LFSC proof language
-
tatam
Theory And Time Analysis Machine
-
linear_isomorphic
A set of traits to astract over linear-like types
-
bumbuna_sum
Add two numbers
-
rust-miller-rabin
Miller-Rabin primality test
-
astro-float
Multiple precision floating-point numbers library
-
land-calc
This app reads a list of mtg cards from 'list.txt', searches scryfall.com to validate them, and figures out how many lands you need
-
periodic-table-rs
A chemistry library written in Rust
-
piss
PISS (Picture Secret Steganography) is a command line tool to encode/decode secrets into/from image files
-
brevet
Evaluator for Ei calculus with dependent merges and first class environments
-
circadian_tools
Tools for working with circadian data, or data that is cyclical like time of day
-
usze
Sometimes you just need a calculator
-
xldenis/creusot
prove your code is correct in an automated fashion
-
calculator-lib
calculator library
-
symba
Computer Algebra System written in Rust
-
quadrature
several fast numerical integration methods. This library is pure safe rust, and cross-platform. The double exponential algorithm is naturally adaptive, and does not allocate.
-
classgroup
class groups in Rust. Uses GMP for arithmetic.
-
rsa_rs
rust rsa library -- UNTESTED HOBBY PROJECT -- DO NOT USE FOR SERIOUS APPLICATIONS
-
find-real-roots-of-polynomial
find all real roots of a polynomial
-
mwa_rust_core
Convenience Rust code that handles coordinate transformations, Jones matrices, etc. for the Murchison Widefield Array (MWA) radio telescope.
-
rs-measures
macros to encapsulate numbers in measures, provided with units of measurement, allowing any meaningful operation, but statically forbidding meaningless operations with them
-
rect-iter
Iterator for 2D rectangle areas
-
add-simple
adder for different nums
-
caliph
calibrate and convert pH measurements using a two point method
-
thermolib
An open-source library for the calculation of fluid properties
-
unifac
calculate non-ideal vapor-liquid equilibria using UNIFAC model
-
ctclib
A collection of utilities related to CTC, with the goal of being fast and highly flexible
-
ipopt_bindgen
Rust bindings to the C interface of Ipopt, a library for large-scale, constrained, nonlinear optimization
-
angular-units
representing, manipulating and converting between angular quantities in various units through a type-safe interace
-
ommx
Open Mathematical prograMming eXchange (OMMX)
-
symbolic_math
performing symbolic mathematics. Supports basic arithmetic operations, expression simplification, and expansion, and evaluation.
-
numerical
Algorithm for numerical analysis
-
gstools-core
The core functions of GSTools
-
p3-monty-31
Plonky3 utilities for implementing 31-bit Montgomery fields
-
termcalc
Terminal Calculator
-
slice_math
A selection of useful math operations on slices
-
nd_vec
A compile time n-dimensional vector library
-
rpn_calc_taro_kobayashi
RPN(Reverse Polish Notation) library
-
calcer
nice program to write graphs from programs
-
aljabar
A super generic, super experimental linear algebra library
-
triangle
Struct for geometric triangles. Includes Barycentric-Cartesian transforms and stuff..
-
ls_solver
linear system solution
-
rustrix
Supports macro and basic operations for matrix
-
const-trig
providing const trig functions
-
simply_2dpga
A 2d vector math library using 2d projective geometric algebra! Designed to be programmer-friendly, specifically because I wanted to use PGA in game development. Development is ongoing.
-
gplu
Sparse LU factorization with partial pivoting
-
ebene
A unique search technology
-
irating
Estimate iRacing iRating changes
-
trilean
Kleene's three-valued logic (boolean + unknown)
-
gcv_spline
fitting and evaluating GCV splines
-
winit_event_helper
Simplified winit event handling using callback functions
-
hebrides
Implementations for the real numbers, complex numbers, and basic linear algebra
-
canrun
A logic programming library inspired by the *Kanren family of language DSLs
-
magnitude
infinity and beyond!
-
lin-alg2
Vector and quaternion operations for general purposes
-
feo-math
Math library for 3D transformation
-
scad_tree_math
Math library for scad_tree
-
mixed-num
A trait for generic implementations of numerical methods
-
stroke
zero-allocation library providing const-generic implementations of Bézier curves, B-Spline curves and specialized implementations of up to cubic Bézier…
-
lineq
Linear algebra library
-
ellp
Linear programming library that provides primal and dual simplex solvers
-
splinosaurus
flexible spline and surface library
-
voicecode
calculator for Produce Traceability Initiative
-
qunit
Experimental uom-like library which enables compile-time verification of dimensional analysis, with support for statically-sized vectors and matrices
-
praytimes
Muslim prayer times calculation
-
arthroprod
Clifford Algebra based computation for the theory of Absolute Relativity
-
arithmetic_congruence_monoid
Реализует арифметические конгруэнтные моноиды (ACM) в проекте на основе YAML
-
oat_rust
User-friendly tools for applied topology
-
decimal
floating point arithmetic for Rust
-
map-range
map a value from a range to another range
-
qmat
2-dimensional matrices
-
qcd-sme
numerical library for the screened massive expansion of QCD
-
mathie
math type library
-
pnets
A framework for Petri net manipulation
-
tfpc
Team Fortress Price Calculator
-
igsolve
The program for solving impartial games
-
juxt_matrix
just matrix, nothing else
-
ferric
A Probablistic Programming Language with a declarative syntax for random variables
-
math_matrix
highschool level matrix implementation
-
MFEKmath
supplies mathematics and algorithms for manipulating beziers
-
sloword2vec
A naive implementation of word2vec
-
eletric_calc
Calculator for Ohm's law
-
haversine-rs
some helpers functions to calculate the distance between two points on Earth using the Haversine formula
-
linxal
Linear Algebra package with rust-ndarray interface
-
calculatex
A pretty printing calculator with support for units
-
rustitude-gluex
GlueX Amplitudes for Rustitude
-
simplicial_topology
Represent, manipulate, combine and perform computations on simplicial complexes
-
demo_test_add_2_numbers
Function for adding 2 numbers
-
fractionfree
Fraction-free linear algebra for ndarray
-
stack-algebra
Stack-allocated lightweight algebra for bare-metal rust
-
ieee754
Low-level manipulations of IEEE754 floating-point numbers
-
mrgraph
High-level Meritrank library
-
commuter
tooling to test diagrams for commutativity, allowing automated tests on algebraic systems
-
collatz_conjecture
A small project demonstrating the collatz conjecture, a maths problem
-
rust_math
Math library written in Rust
-
vdtfont
converting glyphs into triangulations
-
factorio-lua-src
Sources of Lua 5.1/5.2/5.3/5.4 and logic to build them. Fork with Factorio lua.
-
mathguru
An algebra system capable of mixed numeric and symbolic computation
-
generalized-bulletproofs
Generalized Bulletproofs
-
matrix-rs
using matrices in rust. Uses const generics to ensure compile-time matrix safety.
-
calculator-rs
Calculator is a library which support calculates the value of string
-
poset
posets
-
rust-test-crate-multiply
Test rust package
-
i48
working with 48-bit integers
-
maria-linalg
linear algebra processing package
-
del-candle
differential geometry/rendering for huggingface::candle
-
qvnt-i
Advanced quantum computation simulator
-
saturating_cast
saturating casts between integer primitives
-
treelite
rust wrapper for treelite, only support predictor.predict_inst method now. Requires treelite:0.93
-
rusty-rootsearch
This package implements general one-dimensional root-finding algorithms built on the shoulders of the num_dual crate
-
machine-prime
ne plus ultra primality testing for machine-sized integers
-
geometry-rs
geometry utils
-
parry2d-f64
2 dimensional collision detection library in Rust. 64-bit precision version.
-
f128
Bindings to the gcc quadmath library
-
bose
mathematical and scientific formulas
-
dc-ock
reverse polish notation desk calculator library
-
googology
giving names to large numbers
-
bitmath
Tools for arbitrary-sized bitwise arithmetic
-
rust-strictmath
Rust portable strict math implemention
-
tinyfield
Small, finite fields
-
rubikmaster
Tools to implement Rubik's cube applications
-
midpoint
Extension traits offering implementations of midpoint [currently, only for primitive integers]
-
math-commons
math utils for rust
-
shunting-yard
shunting yard algorithm implementation in Rust
-
rust-latex-doc-minimal-example
Minimal crate example for getting latex in docs
-
polynominal-interpolation
interpolating a function using polynomial
-
derangement
permutation with no fixed points, a derangement
-
microtensor
Automatic differentiation for tensor operations
-
takuzu
(a.k.a. Binairo) number puzzle solver
-
prop
Propositional logic with types in Rust
-
radix-number
Rust port of Radix Core Number
-
xxcalc
Embeddable or standalone robust floating-point polynomial calculator
-
arithmetic_yukinari
arithmetic library
-
job-runner
background job runner with configurable delays between job runs
-
fcwt
Fast Continuous Wavelet Transforms
-
sleef-trig
Port of a few sleef.org trigonometric functions
-
rust_geometry
A geometry library for problems in ICPC programming contests
-
tnt
runtime validated proofs in number theory
-
factorial
Convenient methods to compute the factorial, optionally checked
-
noise_fn
Some simple noise functions and traits to allow easy integration with your own
-
clipcalc
calculator that reads from the clipboard and writes the result back to the clipboard
-
permutations
generating permutations
-
mathew
Mathematical expression evaluator with context
-
frond
dynamic lexicographic containers
-
array_math
A selection of useful math operations on arrays
-
nalgebra-glm
A computer-graphics oriented API for nalgebra, inspired by the C++ GLM library
-
functions_shared
Test deply crates.io
-
rust-kepler-solver
Efficient solvers for the elliptical and hyperbolic Kepler equation
-
apbool
Just arbitrary precision boolean arithmetic for Rust
-
eccodes-sys
Low-level Rust bindings for latests ecCodes version
-
cip_rust
Cubic Interpolation Pseudo-Particle (CIP) implementation in Rust. For more information, contact mgubolin at protonmail dot com or the original article in TAKEWAKI, Hrn; NISHIGUCHI, A…
-
cons-laws
Particle methods to solve 1D conservation laws
-
iomath
fast math rust-library
-
wrapping_coords2d
Translate between 1D indices and 2D coordinates with wrapping
-
triangle_sides
calculating various properties of the triangle. Does not use points, but sides lengths for constructing a triangle
-
rs-stats
Statistics library in rust
-
vexide-math
Commonly used mathematical formulas for vexide
-
perplex_num
Perplex (hyperbolic or split-complex) numbers based on num-traits
-
mathvites
An upcoming batteries included library for all things mathematics
-
ctclib-pp
A collection of utilities related to CTC, with the goal of being fast and highly flexible, with perplexity scores for KenLMs models
-
faer-evd
Basic linear algebra routines
-
guff
Implements Galois Fields for various natural sizes
-
const-decimal
Integer-backed decimals with constant precision
-
makima_spline
modified akima spline interpolation
-
sparse21
Sparse Matrix Solver
-
progress-monitor
Track any progress
-
fuzzycomp
Comparison with margins
-
sequential-integration
Lightweight library for sequential integration
-
wsb-rs
Calculates when your options will print
-
nrfind
A set of useful mathematical functions for floating point numbers based on the Newton-Raphson method for finding roots
-
parity
is_even and is_odd methods for primitive numeric types
-
aurora-engine-modexp
Custom ModExp implementation that used in Aurora Engine
-
wgm
A fast and simple math library for game and graphics development
-
const_fixedp
A const type for fixed point arithmetic
-
reiterator
Lazy repeatable caching iterator that only ever calculates each element once
-
mymatrix
My simple matrix library that can perform fraction operations
-
symmetria
numerical library
-
divisors
A blazing fast library to find all divisors of a natural number
-
adder_trial
has a function
-
levitate
Just works solution to numbers, mainly aimed at floats and mathematical use cases
-
nthD_Matrix
using matrixes of any arbitrary size and dimension
-
padic
P-adic numbers in Rust
-
fib-sequence
retrieving fibonacci numbers in base 10
-
simple-geom
plane geometry
-
easygradecalculator
easy grade calculator
-
propositional
Logic
-
choice
Similar to
either
but supports an unbounded number of variants -
replicante_logging
Replicante common logging logic
-
minifloat
Emulate various minifloats with const generics
-
common_math
A collection of common math functions
-
better-num
Better numeric types in rust
-
arpack-ng
Save interface to arpack-ng-sys
-
sat-rs
A SAT solver written in Rust
-
dashu-int
A big integer library with good performance
-
smartcalc-tauri
Text based calculator for peoples supported in Tauri
-
math-in-rust-doc
Demo of add math to rust doc
-
matrix_operations_cuda
perform matrix operations using cuda
-
eigs
Find Eigenvalues and Eigenvectors with Rust using UMFPACK + ARPACK
-
perfect-decimal
Limited range decimals which serialize as IEE754 floats with no loss of precision
-
temperature_calculator
A temperature calculator
-
chemrust-nasl
New Adsorption Site Locator (NASL) for catalyst materials. Written in rust. Part of the
chemrust
toolchain. -
gac
Generic and Atomic Recipe Calculator for Factorio
-
basic_dsp_interop
Digital signal processing based on real or complex vectors in time or frequency domain
-
omni-wave
Easy to use DWT (Discrete Wavelet Transform) library, no need to worry about padding, and a variety of wavelets are available
-
geologic
Mathematical and geometrical abstractions with a focus on ergonomics
-
multifactorials
who allows you to use multi factorials
-
collatz
Helper functions related to the Collatz conjecture
-
num_base
manipulating with numbers (integers) in different bases
-
hipparchus-mean
A collection of basic mathematics solver: Lp norm, mean, moving average, sequence
-
algeo
Computer algebra, algebraic geometry, and related math
-
rbop
Rust framework for writing mathematical expression editors
-
rubiks-moves
focusing on processing moves for 3x3 Rubiks cube
-
plonkup
A pure-Rust implementation of the PLONK ZK-Proof algorithm
-
batbox-la
Linear algebra
-
factor-semiprime
Pollard's rho algorithm for factoring semiprime numbers
-
bidimensional
A collection of 2D utilities for coordinate representation and manipulation
-
rlife
A life library written in Rust
-
markovgen
building markov chain graphs from text datasets and performantly generating text sequences by traversing them, includes an accompanying CLI application
-
approxeq
A trait for approximate equality of types
-
cell-automata-1d
Look Stephen Wolfram's cellular automata: https://www.wolframscience.com/nks/p170--cellular-automata/
-
evalr
Expression evaluator
-
raekna
combines the other crates in the workspace to make a functional program
-
signed
working with signed numbers' absolute values avoiding confusion
-
zero_based_index
Newtype offering some utility methods for zero-based indices
-
dinglebit_combinatorics
A collection of combinatorics utilities
-
ngeom
Geometry in N dimensions
-
cmn
accessing a collection of mathematical and cryptographic constants
-
easy_complex
Complex numbers crate
-
nice-numbers
Small library for number sequences
-
pmsim
Porous media simulator
-
ios_calculator
iOS calculator implementation
-
polygonical
2d polygon geometry and operations
-
tmn
Instrument for working with complex numbers and quaternions
-
duckworth-lewis
A calculator for determining targets for the team batting second in weather affected cricket matches using the Duckworth Lewis Standard Edition methodology
-
advancedresearch/scomb
A research project in path semantics, a re-interpretation of functions for expressing mathematics
-
ezy
Easy to use tweening library
-
multi_dim_point
multi-dimensional point
-
cubecl-core
CubeCL core create
-
lambert-bate
A fast solver for Lambert's problem
-
sylvan_number
My own big number implementation, just for my own uses
-
stochastic-gbm
simulating Geometric Brownian Motion (GBM) process for financial asset modeling
-
mdbook-mathpunc
An mdbook preprocessor that prevents line breaks between inline math blocks and punctuation marks when using katex
-
fang_oost
implementing Fang and Oosterlee's algorithm for inverting characteristic functions
-
triton-air
The Arithmetic Intermediate Representation (AIR) for Triton VM
-
libdivide
Port of libdivide
-
sleekfft_rs
A high performance FFT library for power of 2 signal sizes
-
crlibm
Binding to CRlibm, a correctly rounded math lib
-
vecto
vector2
-
factor-rs
A command-line program for listing the prime factors of a number or fraction
-
discrete-logarithm
Fast discrete logarithm solver
-
num-ord
Numerically ordered wrapper type for cross-type comparisons
-
r-src
The package provides a source of BLAS and LAPACK via R
-
vectorial
Vectors and related types
-
pcw_fn
Generic piecewise function trait and impls
-
unit-prefix
Format numbers with metric and binary unit prefixes
-
colon
A array and number utility functions
-
mazer-macros
A minimal, simple math markup language that compiles to HTML, written in Rust
-
repetend_len
repetend lengths
-
square_calculator
Square Calculator
-
snafu-numbers
Special Numeral-Analogue Fuel Units
-
mathbox
A math toolbox
-
gandiva_rust_udf
gandiva rust udfs
-
symbolics_core
Core expression module for the symbolics computer algebra library
-
pnets_shrunk
A reducer for petri nets
-
deltav_calc
Allows you to generate a graph representing a delta'v map used in the game Kerbal Space Program
-
scalar-field
Traits and structs which define arithmetic operators on scalar fields
-
matriarch
A Linear Algebra and Matrix library written in Rust
-
mermaid
Experimental Linear Algebra
-
sofa-sys
Standards of Fundamental Astronomy (SOFA) Rust bindings
-
machine_int
std::num::Wrapping on steroids
-
lie
A numerical library for working with Lie Groups and Algebras
-
mc-vanilla
MinecraftRS - Implementation of vanilla features for Minecraft, this extends and use mc-core
-
claire_vector
claire is a rust lib for vector calculus
-
fsum
calculate accurate sum of floats
-
unit-root
Unit root tests
-
q_rsqrt
fast inverse square root function from quake 3
-
fts_units
that enables compile-time type-safe mathematical operations using units of measurement
-
eigenvalues
algorithms to compute eigenvalue/eigenvectors of symmetric matrices
-
commander-core
used by commander-rust only. Please don't use it!
-
colsol
Functions for direct solution of matrix equations for compact form matrices
-
rs_handstrength
relative to board omaha hand strength calculator and equity on flop
-
libpuri
Idiomatic Rust Competitive Programming Library
-
nvblas-sys
This package provides linkage to NVBLAS
-
simplex-23d-rs
Simplex 2d/3d noise in Rust
-
fixed-exp
Exponentiation for fixed-point numbers
-
surreal
that implements J. H. Conway's surreal numbers
-
cisat
Cognitively-Inspired Simulated Annealing Teams
-
srmc
A Small Rust Math Crate
-
natural_constants
Pre-defined constants from all disciplines (math, physics, ...)
-
curso_09_libs
Teste de biblioteca
-
polygon_clipping
An algorithm for computing boolean operations on polygons
-
coinclp-sys
The low-level bindings to the COIN-OR Clp library
-
cheque
Convenient checked math
-
adder123
A father package file where you guess what number the computer has chosen
-
tau
The important mathematical constant tau
-
q1tsim-logic-gates
extension crate to q1tsim implementing the AND, OR and XOR logic cates in a quantum comupting - friendly (i.e. reversible) way.
-
simulated_annealing
An interface for global function optimization using simulated annealing
-
hypercpu
Distributed symbolic computation
-
gs-rs
basic monocular SLAM (Simultaneous Localization and Mapping) Algorithm in pure Rust
-
persist-es
A backing logic for an RDBMS implementation of an event store for cqrs-es
-
siffra
parse and evaluate human-friendly mathematical and natural language expressions
-
dfa
A simple dfa
-
lapack-traits
Generic real/complex scalar trait wrappers for BLAS and LAPACK routines
-
cycle
modern and safe symbolic mathematics
-
radix-tools
Tools for computing powers or decomposing numbers by radix
-
MathTriks
A single crate for every mathematical manipulation
-
sjqchat
-
crook_calculator
one function to compute mathematical equations from string slices
-
real_float
Floating point types that check for correctness and implement total ordering
-
p3-interpolation
Plonky3 interpolation logic
-
FEA_code
-
circomspect-circom-algebra
Support crate for the Circomspect static analyzer
-
arb-sys
Bindings to the Arb library
-
polynomial-roots
Find the real roots of huge polynomials in milliseconds
-
ndvec
low-dimensional vectors
-
implicit3d
3d implicit geometry
-
My-7
I'm getting used to Rust
-
siiir_modular_power
A console app and library with function to quickly calculate k^n mod m
-
epsilonz
Functional programming in Rust
-
rs-lambda
A lambda calculus interpreter written in rust
-
moon-calc
Moon phase calculator
-
lager
A lightweight type-safe linear algebra library
-
rate
Clausal proof checker (DRAT, DPR) for certifying SAT solvers' unsatisfiability results
-
rml
A machine learning library in Rust
-
sparkl3d-kernels
3-dimensional physics engine in Rust
-
pythagore
Mathematics tools for simple geometry
-
mathcat
Math Capable Assistive Technology ('Speech and braille from MathML')
-
ewq
Small math library
-
envisim_estimate
Design-based estimation and variance estimation
-
num-derive
Numeric syntax extensions
-
cchmod
chmod calculator
-
unsigned-f64
A wrapper around f64 that guarantees that the value is always non-negative on the type level
-
glar-gemm-c64
high performance cpu kernels
-
rawarray
file format for retrievably storing n-dimensional arrays
-
image-recovery
Image recovery algorithms, implemented in Rust
-
tricolor
Color structs, color formats, and color conversions
-
nabo-pbc
A fast K Nearest Neighbor (KNN) library for low-dimensional spaces, now with support for periodic boundary conditions
-
piecewise-linear
manipulating piecewise linear functions
-
machine-check-exec
formal verification tool machine-check
-
mdmath_ia
Multidimensional math
-
hilbert_index
D-dimensional Hilbert curve
-
upcast-arithmetic
Arithmetic that is upcasted on overflow
-
reuler
Solutions to Project Euler in Rust
-
npy-stream-writer
stream writer for numpy files
-
makepad-geometry
Geometry tools
-
xer_add_one
Example dependency crate
-
operations
Basic algebraic and mathematical expressions for use with dynamic elements
-
ferrix
matrix library for Rust
-
tropical_algebra
tropical algebra in Rust
-
spv-rs
Math utility for astronomical data
-
gfx-maths
Implementations for the most essential Graphics Math operations
-
gomez
Framework and implementation for mathematical optimization and solving non-linear systems of equations
-
spice-sys
Thin wrapper for the C language implementation spice toolkit from NAIF
-
graph_gen
Generate pseudo-random graphs based on the Erdos-Renyi G(n,p) model
-
spartan-codec
A proof-of-concept encoder for the Subspace Network Blockchain based on the SLOTH permutation
-
delaunay2d
compute Delaunay triangulations and Voronoi diagrams in 2D space
-
vectors
Sparse & dense vectors for use in high dimensional vector spaces
-
RustPrimeNumberLibrary
Rust prime number checker library now step 1 is importing create and calling function and put one parameter. This prameter data type is u32
-
sin_cos_ln_sqrt
ITN crate containing math functions
-
voroxx
Voro++, a 3D cell-based Voronoi library
-
linear_algebra
basic linear algebra operations in Rust
-
tritet
Triangle and tetrahedron mesh generators
-
num-primes
Generating Large Prime and Composite Numbers using num with a simplistic interface
-
mathlib
A math library for Rust
-
polygamma
function
-
nd_interpolate
1-10 dimensional linear and cubic spline interpolation implemented in Rust
-
ferromagnetic
Calculate the world geomagnetic fields using IGRF/WMM
-
foocalc
A command line RPN calculator with multiple precision and unit support
-
matchmaker
fairly match students to categories
-
truthful
A logical expression parser, optimizer and evaluator
-
RustQuant_iso
quantitative finance
-
fj-kernel
Early-stage, next-generation, code-first CAD application. Because the world needs another CAD program.
-
safemath_dev
Math operations with safety checks that throw on error
-
calculi
used to apply calculus functions on equations in string form
-
yestack
Tools from me
-
onechatsocial-permissions
Revolt Backend: Permission Logic
-
camctrl
Camera control math
-
opensrdk-symbolic-computation
Standard automatic differential library for OpenSRDK toolchain
-
currying
anything implementing FnOnce. Arguments can be passed one at a time, yielding a new something implementing FnOnce (and possibly FnMut and Fn) which can be called with one less argument.
-
whiteboard
A math library made by someone not qualified to be making math libraries
-
sophus_opt
sophus - geometry for robotics and computer vision
-
hwcalc
An arbitrary bit-width calculator
-
hipparchus-geo
latlon, ellipisoid & geodesic calculations
-
adder_4702
This package calls the
add_one
function from theadd_one
library -
vlink
made for emberry https://github.com/emberry-org/emberry
-
alphabet
working with alphabets
-
egglog
language that combines the benefits of equality saturation and datalog. It can be used for analysis, optimization, and synthesis of programs. It is the successor to the popular rust library egg.
-
hc
Handy calculator for haxor calculations
-
geometric
A very simple vector and matrix library built on the vecmath crate
-
primal-sieve
A high performance prime sieve
-
magnet_rs
User friendly magnetic field calculations in Rust
-
hwcalc_lib
Backend for the hwcalc calculator
-
sinorust
hello world!
-
nekocalc
A Calculator
-
topological_peak_detection
A mostly efficient topological algorithm for finding all peaks in a 1-D signal
-
acme-graphs
Computational graphs for Rust
-
math_captcha
mathematical CAPTCHA code generator written in Rust
-
bignumber
arbitrary-precision decimal and non-decimal arithmetic
-
hkkim_lib_wikibooks_rpn_test
RPN(Reverse Polish Notatio) library
-
electro
A small toolkit for computational electromagnetics, including FD, MM, and FEM. Unstable till 1.0.
-
fpn
Fixed point number
-
quake-inverse-sqrt
Quake Inverse Square root alghorithm
-
hexx
Hexagonal utilities
-
maiden_nn
Maiden NN
-
magnesia
A math library for Rust
-
na
wrapper around nalgebra to make it easier and mostly less verbose to work with the most used types in vector math for graphics
-
numerical-integral
evaluating integrals using numerical methods
-
demo_crate_dia
Calculator
-
isprime
Quickly check if a number is prime
-
pirox
building a calculator
-
vajra
-
kilac
Handles Kipa-compatible inputs. Prototype of Riipic
-
aint
Arbitrary width integers between 1 and 128
-
lukkid
Arithmetic Sequences
-
mathfacts
A small command-line application to practice math facts
-
avatar_graph
Avatar Graphs
-
smartcalc-tui
Terminal UI for erhanbaris/smartcalc
-
temp-converter-lib
terminal temperature unit converter between Celsius, Fahrenheit and Kelvin
-
thirteensea
Test publish crate
-
ralgeb
This package has some mathematical tools to allow user perform operations on Point, Line, Circle, Matrix
-
avlsort
AVL tree holding the rank and the number of duplicates of elements
-
cmath
一个新手的尝试
-
log_domain
Logarithmic representation of floats
-
pupil
Arithmetic expression evaluator
-
oxicalc
A small, simple calculator written in rust/gtk4
-
slintcalc
A little calculator
-
det
Calculate the determinant using a macro
-
strata
A unique search technology
-
trajgen
Minimum trajectory generator
-
delaunay
The representation of delaunay triangulation
-
iter-rationals
A fixed size, linear time, no-std iterator over the rational numbers
-
simple_math
lib to do some mathematical manipulation
-
commonfunctions
packge
-
clnooms
Assembly-level implementation of interesting data types
-
frames
Contextual frames made simple
-
twoword
Construct bigger uints by combining two smaller ones into a two-word uint
-
galgebra
geometric algebra stuff (vectors)
-
rapier3d-urdf
URDF file loader for the 3D rapier physics engine
-
small_matrix
matrix library made in Rust
-
options-common
working with financial options
-
logsumexp
Numerically stable computation of log-sum-exp using a 1-pass algorithm
-
nd_array
linear algebra that tries to have a similar api to numpy
-
pccc
Parallel-concatenated convolutional code
-
unit17
whp-unit17
-
gosh-lbfgs
Fast and safe Rust implementation of LBFGS and OWL-QN algorithms ported from Naoaki Okazaki's C library libLBFGS
-
unit9
whp-unit9
-
cassie
limited computer algebra system written for the fun of it
-
rust-polynomial
A lib to operate polynomials
-
fj-app
Early-stage, next-generation, code-first CAD application. Because the world needs another CAD program.
-
com-croftsoft-core
A core library of highly reusable code
-
theta-chart
Theta_chart is a collection of utilities to make performing certain calculations more convenient
-
polys
A package for polygon geometry
-
ralgebra
Roy's algebra library
-
ux-indicators
Technical Analysis Function Library
-
dimensional
Functions, structs, and reference data for working with dimensional values, such as '1 second' and '3 miles per hour'
-
nodarium_utils
A collection of utilities for Nodarium
-
amfnengine
Amortization Functions (AmFn) Engine
-
field-matrix-utils
working with matrices over finite fields
-
gauss_adia
Small utility program to compute adiabatic energies for TD-DFT simulations with the gaussian 16 program suite
-
core-math
API for CORE-MATH
-
sturdy-couscous
URI redirect in rust business logic repo
-
normform
handling normal forms
-
inari_wasm
A stripped-down version of Inari library (a Rust implementation of interval arithmetic) compatible with web assembly
-
cadical
Rust bindings for the CaDiCaL SAT solver
-
tiny-dl
An experimental crate for exploring Description Logic
-
adder-zfk-rs
A add one function crate by zfk
-
metallicalc
A calculator written in Rust
-
meansd-cli
calculate mean and standard deviation (CLI)
-
astro_nalgebra
astro-float for nalgebra
-
second_class
add two numbers
-
sukker
Linear Algebra and Matrices made easy!
-
fend-core
Arbitrary-precision unit-aware calculator
-
algebr
Basic algebra
-
numera
numbers
-
rexl_matrix
matrix library for Rust
-
fractran_rs
A FRACTRAN interpreter
-
l1-dfa
Deterministic Finite-State Automata Library for Rust, written in L1
-
lemonmath
A math library
-
smt-lang
Sat Modulo Theory Language
-
batbox-num
num traits
-
math_64
Only the numbers 1, 3, 5, 7 or 9 work. It's very odd.
-
iron-shapes-algorithms
Geometric algorithms for the iron-shapes geometry crate
-
modern_appvars
A parser for appvars on TI calculators
-
doem-math
Const generic linear algebra math crate for 3D applications, made in conjunction with doem
-
ticktick
-
rusoda
Pure rust and just need log dependencies implementation of odepack dlsoda
-
routrs_railways_dataset
Railways dataset for routrs, the geograph-based shortest distance calculator for Rust
-
siege-math
Math library for the Siege Engine
-
raith-common
learning project
-
unit18
whp-unit18
-
pga2d
tools for 2 dimensional projective geometric algebra
-
modulo-n-tools
modulo tools
-
poly-mesher
Meshing but poly
-
locmess
look at the mess that are your LOC
-
eprmutate
Permutation Library
-
exprtk_rs
Rust bindings to the ExprTk C++ library (http://www.partow.net/programming/exprtk)
-
set-partitions
Represent and enumerate set partitions
-
simplify-polyline
Simplify polylines using Douglas-Peucker and radial distance algorithms. Port of the simplify-js library.
-
dimensions
Struct(s) for handling dimensions
-
ferrischart
Build informative graphs in Rust
-
cufft_rust
A safe cuFFT wrapper
-
cartesian_trajectories
create cartesian motion profiles
-
haversine-redux
Haversine formular library to determine the distances between two coordinates on the earth
-
lorust
Modern Rust utility library delivering modularity, performance & extras; or simply Rust version of Lodash
-
poke-type
A Pokemon type effectiveness calculator that accepts arbitrary type combinations
-
cp_sat
Rust bindings to the Google CP-SAT constraint programming solver
-
jl-sys
contains the generated bindings for the Julia C API used by jlrs
-
stitches
Search spaces to solve math problems fast
-
fuzzy_fraction
Struct for approximated human-readable fraction representation
-
matrix_operations
perform matrix operations
-
versor
port of versor in D3.js
-
rust-numpy
A row version of a convinient rust-numpy library which target is to dublicate functionality of well known python library 'numpy'
-
fhe-math
Mathematical utilities for the fhe.rs library
-
p3-circle
Plonky3 logic relating to the circle group
-
entropiter
A no-dep iterator-compatible frequency and Shannon entropy calculator
-
bmi-calculator
BMI calculator for TI Nspire™, with data for Chinese
-
combinatorial
tools, functions, and generators
-
matrix-math
Mathematical matrices
-
hann-rs
Blazingly fast Rust Hann Window
-
tofas_extras
Translation of fundamental astronomical subroutines
-
tilted
A toy mathematical interpreter written in Rust
-
seniorious
chtholly tree in rust
-
vtrig
Hidden trigonometry functions with their derivates and integrals
-
ty-ops
Type level operation library in rust
-
graph-cycles
Detect all cycles in a petgraph graph
-
iof
Read from and write data to console or file in simple formats
-
ranged
Implements math operators for ranges of numbers
-
firmath
Math Library for Graphics
-
coincbc-sys
The low-level bindings to the COIN-OR Cbc library
-
super-prime
Find the super prime number
-
idem
0 and 1
-
calcul8
calculator CLI
-
dashu-ratio
A big rational library with good performance
-
toronto
Tools from me
-
precise-calc
A high precision calculator library and command line tool
-
GSL-sys
binding for the GSL (the GNU scientific library)
-
tukey_test
performing the Tukey statistical test, a method for comparing multiple groups simultaneously. It calculates the critical q value for a given number of groups and total observations…
-
scotch
Idiomatic wrapper for Scotch, the graph partitioner, graph clusterer and sparse matrix orderer
-
kahuna
A basic implementation of wave-function collapse for procedural generation
-
shawnkelz_add
A test crate created by Shawnkelz
-
conum
big numbers, specified by arbitrary digit widths
-
cryptix-field
group, ring and field arithmetics based on cryptix-bigint
-
data-pipeline
A functional and extensible library for organized lazy processing of data with minimal overhead
-
css_math
Tokenizes and validates strings as CSS Math statements
-
matrix_mul_test
testing blas as a feature
-
markovian
Simulation of Markov Processes as stochastic processes
-
libmath
Mathematical utilities
-
kukan
powerful tool for mathematical interval
-
oxygen_quark
Oxygen Quark is a maths library mainly developed for the Oxygen Game Engine
-
rialight_math
Rialight mathematics API
-
sprs-ldl
Sparse cholesky factorization
-
bool2cnf
transfer boolean expression to dimacs directly
-
topology-traits
Topological traits for generic mathematics in Rust
-
pdbs_benchmark
The program for benchmarking pattern database implementations
-
aws_volume_limit_calculator
copy of https://github.com/awslabs/aws-support-tools/blob/master/EBS/VolumeLimitCalculator/volume_Limit_calculator.sh
-
asmcahligzamaze
Schizm and amalgamation of adventurer's probability distribution across multiverse 2D maze on a single screen
-
luacells
text-based cellular automata simulator that uses Lua for rule definitions
-
argmin-math
argmin math abstractions
-
bicubic
A base for bicubic interpolation
-
fftw-sys
unsafe wrapper of FFTW3
-
wgebra
Composable WGSL shaders for linear algebra
-
ndmath
Traits for doing vector geometry operations using built-in types
-
lib_algorithms
Библиотека алгоритмов
-
miller_rabin
A multi-threaded, arbitrary precision implementation of the Miller-Rabin primality test
-
kolakoski
sequence iterator
-
acme-tensor
A comprehensive tensor library for Rust with support for automatic-differentiation
-
online-statistics
Blazingly fast, generic, and serializable online statistics
-
logik
Calculator for propositional logic formulas
-
coin_cbc_sys
Rust bindings to the CoinOR CBC MILP Solveur using the C API
-
kair
COnstraint Based Reconstruction and Analysis (COBRA) in Rust
-
zkp-elliptic-curve
A crypto-grade elliptic curve over
primefield
-
rustnomial
working with polynomials
-
moonalloy
The oxidized scientific computing library for the 21st century
-
legasea_line
Tools for working with lines
-
astronomical-quantities
Unit-safe computations with astronomical quantities
-
yttria-modulation
A communications library tailored for use with the yttria set of libraries
-
rslogic
logic programming framework for Rust inspired by µKanren
-
Circle_Area
circle of area function
-
fixed-vectors
Lightweight library implementing fixed-length vectors for Rust applications not compiled with the standard library
-
nalgebra-lapack
Matrix decompositions using nalgebra matrices and Lapack bindings
-
math-fun
A package providing mathematical functions commonly used in science and engineering
-
directx_math
translation of DirectXMath, a SIMD linear algebra library for use in games and graphics apps
-
memu
Implementations of memory units and working with them
-
unit4
whp-unit4
-
lsode
Solve systems of differntial equations using LSODE subroutine from ODEPACK written in Fortran
-
suitesparse_graphblas_sys
Rust bindings for SuiteSparse::GraphBLAS
-
acgmath
A linear algebra and mathematics library for computer graphics. A fork of
cgmath
. -
rustybit-lib
that backs the rustybit BitTorrent client
-
geo-aid-script
Geo-AID's subcrate for parsing GeoScript
-
rust_scicrate
A scientific computing library for Rust
-
approximately
compare two any values
-
my_very_own_add_one
add one to a number
-
matriz
Zero allocation Rust linear algebra library
-
rusty-compression
Low rank compression algorithms in Rust
-
gates
simulate logical gates
-
galois_field
convenient operations on finite field, polynomials, and matrices over finite field
-
allen_interval_algebra
package for interval algebra for more information see https://en.wikipedia.org/wiki/Allen%27s_interval_algebra
-
matrixable
Traits and structs extending capabilities of matrix-like structures
-
adv_linalg_lib
Core library for Adv_LinAlg procedral macros
-
meshgridrs
Partial implementation of numpy's meshgrid function for ndarray
-
object-detection-opencv-rust
Object detection utilities in Rust programming language for YOLO-based neural networks in OpenCV ecosystem
-
xldenis/creusot-contracts
contracts and logic helpers for Creusot
-
quickmath
A quick command-line math evaluator
-
sparse_complex
solver for complex sparse matrices
-
algebraic-gen
Procedural Macro for Geometric Products of Any Dimension
-
optlib
The optimization algorithms realized in Rust. In given time realized genetic and particle swarm algorithms.
-
chewy
A command-line RPN calculator
-
fractl_lib
Fractal renderer supporting multithreading, gpu compute and wasm
-
bool-logic
manipulating and evaluating boolean expressions
-
kalc-kman
Is a calculator for math
-
ode_integrate
Collection of numerical ODE Solvers written in generics and thus applicable in many scenarios
-
cblas
The package provides wrappers for CBLAS (C)
-
log2fix
no_std fixed-point base 2, e and 10 logarithm algorithm implementation
-
umath
ffast-math in rust
-
ngau
Non-Generic Angle Units
-
postfix
expression evaluator
-
raster-tools
Raster processing tools
-
jpl-sys
Project Pluto JPL Ephemeris Rust bindings
-
mvmm_hydro
A moving mesh hydrodynamics (CFD) solver prioritizing flexibility over raw performance
-
ruut-algebra
An incredibly minimal linear algebra crate meant to be used for ruut-functions
-
mathical
A powerful, and visual tool for graphing mathematical functions and equations
-
geode
Rust bindings for the Geode SDK
-
conclave-room
Logic for a Conclave Room
-
infinity-euler
These are my solutions to Project Euler implemented in Rust
-
arith_wrappers
Rust’s
std
offers theWrapping
type for “intentionally wrapping” arithmetic, but curiously does not provide analagous implementations for intentionally saturating… -
dotbits
unsigned int <-> Vec<bool>, plus various helper functions
-
ruint-macro
The
uint!
macro forUint
andBits
literals -
duckduckgeo
2d geom library
-
classygroup
The Classy Group
-
ramer_douglas_peucker
Ramer Douglas Peucker algorithm
-
basic_math_operation
can be used to perform basic operations like Addition, Subtraction, Multiplication and Division
-
unit_system
Automatically derived typed unit systems
-
lettuces
A grid logic crate combining Hexx and custom logic for square and isometric grids to provide a unified grid logic crate
-
rug-polynomial
Polynomial arithmetic, built on Rug & FLINT
-
moving-average
moving average library
-
hilbert16
Hilbert transforms between 1D and 2D space, optimized for u16 coordinates
-
millimeter
Primitive type with millimeter unit attached
-
decorum
Total ordering, equivalence, hashing, and constraints for floating-point types
-
faer-cholesky
Basic linear algebra routines
-
array__ops
A selection of useful array operations
-
math_parser
A parser for mathematical expressions
-
gaussfilt
Design and apply Gaussian filter for 1D data
-
yz-curvep-exs
examples of curve paramterizations
-
flowscad
2D graphic and 3D object design with a Rustic functional approach. SVG and OpenSCAD output.
-
psy-math
A fork of jet-proto-math. Helpful math utilities, used by PsyLend.
-
fdecimal
Arbitrary precision fast decimal numbers
-
cl-calc
A command line calculator
-
trussx
designing and analyzing truss structures
-
matrix-calc
matrix addition, subtraction and multiplication library
-
croot
finding real and complex roots
-
cordic
Special functions for fixed-point numbers using the CORDIC method
-
math-symbols
Symbols for computer algebra
-
mady
🌲 ahead-of-time automatic differentiation
-
hcomplex
Lightweight complex and hypercomplex algebra library
-
f64ad
Easy to use, efficient, and highly flexible automatic differentiation in Rust
-
inexor-rgf-plugin-arithmetic
Inexor - Reactive Graph Flow - Plugin - Arithmetic
-
dynagrad
Dynamic Auto-differentiation
-
fibnacci
fast high precision fibonacci calculator using rayon and gmp
-
flexint
Big integer types, optimized for small values
-
ferrous-simple-calc
Example crate: simple calculator
-
mc-core
MinecraftRS - Minimal core implementation of Minecraft backend
-
fibo
Compute the N-th Fibonacci number with arbitrary number precision
-
hipparchus
<!-- TODO -->
-
hipparchus-seq
generate various sequences defined in mathematics
-
font-glyph
draw font glyph outline for Rust with plotters
-
nonstdfloat
Floating point calculations for strafe
-
yttria-math
A DSP math library tailored for use with the yttria set of libraries
-
irox-stats
Various mathematical and statistics utilities
-
antic
bindings for the antic C library for algebraic number theory
-
unitdc
A dc-like arbitrary precision quantity calculator
-
oscirs
Scientific computing environment for Rust
-
max_len_base_10_as_usize
Trait offering constant maximum lengths of primitive integers as usize
-
g3
Neat library for computer graphics based on geometric algebra
-
cnetworks
A set of tools for creating and manipulating complex networks
-
concrete-fftw
Safe wrapper around FFTW
-
goertzel-nostd
An nostd implementation of Goertzel's Algoritm
-
vaughan
Implementations of various scientific calculations a-la SciPy in Rust built on Polars
-
rgaussian16
Interface for the Gaussian16 quantum chemical package. This structure provides functions for auto generating input, and running the external program g16.
-
floorAndCeiling
Tiny crate that contains floor and ceiling functions
-
matlabblas-src
Provide a source for MATLAB's BLAS library for use with the BLAS crates
-
rstm-core
focuses on building concrete implementations for Turing Machines
-
rust-gmp-kzen
Rust bindings for GMP
-
wmathrs
mathematical crate
-
generic_fixedpoint
Generic fixed-point numbers
-
oscirs_linalg
GPU accelerated linear algebra crate for scientific computing
-
rexl_math
mathematics library for Rust
-
slender-math
Lightweight math library for game development
-
summed-area
table for fast sums or averages of subsections of a 2d array or an image
-
rust_mdd
MDD
-
rsruckig
Ruckig motion planning library for Rust
-
binary-space-partition
Abstract BSP tree
-
scal
Calculator that can add, sub, mul & div two input num
-
ida
A pure Rust port of the Implicit Differential-Algebraic solver from the Sundials suite
-
mafs
Fast maths for tiny projects. With SIMD but just for x86
-
matrixes
matrices up to and slightly beyond a highschool level. See README for details.
-
solver
Solve optimization problems
-
math
A math library
-
cayley
generic, stack-allocated linear algebra stuff, such as matrices
-
second_class_demo
add two numbers
-
fj-export
Early-stage b-rep CAD kernel
-
advancedresearch/path_semantics-category
A research project in path semantics, a re-interpretation of functions for expressing mathematics
-
softfloat-wrapper-riscv
a safe wrapper of Berkeley SoftFloat based on softfloat-sys for RISC-V based on https://github.com/dalance/softfloat-wrapper
-
auto_worlds
Worlds implementing different rules for cellular automata
-
mtl
Matrix template library. Dense2D matrix, SparseMatrix.
-
in_range
Returns true if a number is in range
-
bigint-benchmark
Benchmarks for big integer implementations
-
typed_floats
Types for handling floats with type checking at compile time
-
sqrt-rs
Stupidly Fast And LightWeight Crate To Calculate Square/Cubic Root In Different Ways
-
hipparchus-az
angle representation, conversion and calculations
-
mdmath_cg
Multidimensional math
-
rs-math
math library, a math library written in Rust. Write in a native way as much as possible in this math library, reducing the use of third-party libraries. There may be some errors in this math library…
-
pesto_cli
hello there
-
rusty-cffi
Tools for interfacing with other languages via CFFI
-
ndarray-unit
A package providing a system of units to the ndarray type
-
amfnwasm
Amortization Functions (AmFn) Web Assembly
-
hilbert_curve
Hilbert curve mapping algorithms in Rust
-
math_vector
3D vector class
-
qhull-sys
Rust bindings to Qhull
-
ginger-rs
Parallel Bairstow Root-finding Method in Rust
-
time-func
represents a set of data points as a function of time and performs various mathematical operations on the data
-
malltec_libs
Projeto de estudo
-
simple_calculator_cmd
command line simple calculator and library
-
lcpc-ligero-pc
polynomial commitment scheme from R-S codes, as in Ligero (CCS '17)
-
gpurs
GPU acceleration/linear algebra crate for scientific computing
-
spaceform
A cross-platform SIMD-accelerated maths library for 3D graphics
-
modtype
Macros that implement modular arithmetic integer types
-
basiclu
Rust wrapper for BasicLU
-
evercrypt_tiny-sys
A tiny build of EverCrypt's c89-distribution with autogenerated bindings
-
evaluator
interfaces and implementations for logic constructs that return values without accepting arguments, either via closure captures, global state, calculation or otherwise
-
logic-rs
representing logical formulas with support for temporal robustness semantics
-
clac
command-line calculator
-
declaration
parsing mathematical terms
-
primeval
A monstrosity of a prime number generator
-
gt-ltq
solve path graph theory problems on an ltq
-
lapack-sys
The package provides bindings to LAPACK (Fortran)
-
xfft
Fast Fourier Transforms
-
mulberry
Coordinate transformation tree with a focus on efficiency
-
big_num
A big number implement in rust
-
mathematics_table
that will generate a math table of an integer given by the user
-
icub3d_combinatorics
A collection of combinatorics utilities
-
caliphui
calibrate and convert pH measurements using a two point method
-
shape-triangulation
The representation of delaunay triangulation
-
std-dev
Your Swiss Army knife for swiftly processing any amount of data. Implemented for industrial and educational purposes alike.
-
stella
software that finds prime k-tuplets (also called prime constellations)
-
lambash
A λ-calculus POSIX-like shell
-
qmu
Quigly's Math Utility
-
maph
Maths package for use with personal stuff, but like, you can totally use it! If you want! There's even some light documentation now!
-
some_math_lib
A basic math library
-
matio-rs-sys
Rust binder to MATLAB MAT file I/O library
-
dioxus-katex
Render math with KaTeX in Dioxus!
-
tribool
Three-valued logic
-
objforces
Allows to calculate mouvement of objects based on forces on a 3D axis
-
raekna-common
contains common types and functionality for the raekna project
-
factorial-mod
Fast mod for $n! % p
-
arith_traits
Traits unifying types based on various supported arithmetic operations
-
rMaths
Maths library made for Rust developers with ❤
-
mazer-cli
A minimal, simple math markup language that compiles to HTML, written in Rust
-
chapter-3
An attempt at creating a linear algebra crate
-
netlib-src
The package provides a source of BLAS and LAPACK via Netlib
-
jacc
Just another cli calculator: A maths interpreter for the command-line
-
genpet
Generate petgraph graphs with geng
-
reikna
A work in progress math library
-
kalk_cli
A calculator that supports user-defined functions, variables and units, and can handle fairly ambiguous syntax
-
sparse-interp
Basic univariate polynomial arithmetic and sparse polynomial interpolation
-
astro-float-num
Multiple precision floating point numbers implemented purely in Rust
-
advancedresearch/boolalg
A research project in path semantics, a re-interpretation of functions for expressing mathematics
-
mkl-rs-build
Build utilities for MKL
-
ndutest
the first test
-
primerug
A prime k-tuple finder based on the rug crate
-
scicalc-rs
parsing and doing calculations with measurements, typically used in scientific contexts
-
colamd
Column approximate minimum degree ordering algorithm
-
module-publish
module publish test
-
jaredh159-test-adder
adder function
-
ico_math
An opinionated SIMD Math Library for games and graphics in Rust
-
gaussiant
Gaussian integers
-
multrix
matrix multiplication and manipulation library with multithreading support
-
moon_math
Math utility functions for a variety of uses
-
rustometry
Spatial Geometry in Pure Rust
-
nnls
Non-Negative Least Squares (nnls)
-
i_mth
A math library continuously under development made for use in particle and ridgid body dynamics and statics
-
ext-ops
General purpose arithmetic operator traits which are missing from the standard library
-
sized_matrix
Sized matrices using const generics for better type checking and performance
-
intel-mkl-tool
Seek Intel(R) MKL library from system
-
math-rs
A basic mathematical engine
-
planar
Strongly typed planar geometry
-
rmath-cli
cli calculator
-
acm_dependent
Project dependent on the arithmetic_congruence_monoid library for working with arithmetic congruence monoids (ACM)
-
extended
precision 80-bit floating-point numbers (f80)
-
dualquat
Quaternion and Dual Quaternion math library for high-precision physics simulation
-
min_max_traits
Traits for MIN and MAX associated constants
-
rust-expression
Calculator and solver for linear equations
-
geo-aid-geogebra
Support for Geogebra (*.ggb) output from Geo-AID
-
amg_match
Research iterative solver utilities
-
rational_extensions
Extensions for rational numbers
-
cellular-snapp
Create cellular automata
-
acm
Arithmetic congruence monoid implementation in Rust
-
stochastic-abm
simulating various stochastic processes, including Arithmetic Brownian Motion and more
-
iter_num_tools
Create simple iterators over non integer ranges. itertools + num = iter_num_tools
-
beagle
A basic linear algebra library for computer graphics
-
logic_trioxide
Logic Gate simulating Library
-
ajkcalc
scriptable hybrid calculator
-
klu-rs
Save bindings to SuiteSparse's KLU sparse matrix solver
-
glar-dev
high performance cpu kernels
-
arithmetic-sign
Arithmetic
Sign
(≈+1|-1) to/from arithmetic types such asf64
,i32
utility -
exec-sat
Executes SAT solver and parses SAT solver output
-
tsum_calc
command-line Triangle Sum Theorem calculator
-
lmaths
A short 2D Maths library
-
cellular_raza-core
Cellular simulation tool
-
jnk
Jenna's Number Kruncher: a library for parsing math expressions
-
gap_solver
A solver for the generalized assignment problem
-
simple_2d_vector
two-dimensional vectors in Rust
-
datom-bigdecimal
Arbitrary precision decimal numbers
-
awint_core
Core no-std and no-alloc
awint
functionality -
geo-aid-svg
Support for SVG output from Geo-AID
-
inertia
Inertia
-
math_quix
math quiz cli to practice basic arithmetic
-
diet
A Discrete Interval Encoding Tree implementation
-
nicolas
Computational Algebra Library
-
symbolics_calculus
Calculus module for the symbolics computer algebra library
-
points_between
API to list the evenly-spaced discrete points between two N-dimensional points
-
wicker
Weighted probability picker for Rust
-
corries
Library/framework for 1D-hydrodynamics simulations using Riemann solvers
-
guff-ida
Information Dispersal Algorithm
-
metis-sys
Raw FFI to METIS, the serial graph partitioner and fill-reducing matrix orderer
-
routrs_maritime_dataset
Maritime dataset for routrs, the geograph-based shortest distance calculator for Rust
-
double-pendulum
A mathematical model for double pendulums
-
flint-sys
Bindings to the FLINT C library
-
imath-traits
traits for VFX libraries to be agnostic over the math crates used
-
statrs-fork
Statistical computing library for Rust
-
factordb
Rust wrapper for FactorDB API
-
arpack-ng-sys
Bindings to arpack-ng
-
libmat
tools for linear algebra
-
raekna-compute
allows evaluating expressions into literals
-
nikisas
common mathematical functions with focus on speed and simplicity of implementation at the cost of precision, with support for
no_std
environments -
zetik_prime
generating prime numbers with an iterator
-
whittaker_smoother
The perfect smoother: A discrete-time version of spline smoothing for equally spaced data
-
irox-dot
DOT Graph Description Language writer, compatible with GraphViz
-
axb
linear algebra
-
finitediff
Finite/numerical differentiation
-
cereal_lib
Does the cereal box problem in either single or multi-threaded mode
-
doctor-syn
Computer algebra system for Rust expressions
-
mee6
calculate mee6 leveling data
-
rusymbols
symbolic mathematics. It aims to become a full-featured computer algebra system (CAS) while keeping the code as simple as possible in order to be comprehensible and easily extensible…
-
fftconvolve
The fast fourier transform convolution and correlation algorithm for Rust
-
brain-assistant
Mathematics tool and encyclopedia for the terminal
-
bq
A complete implementation of dual quaternions
-
Gen_Prime
A way to transform a hash to a prime number
-
math_thingies
math thingies, traits. For self use
-
command_line_calculator
command-line calculator
-
vecn
A procedural macro that transforms user-defined structs into general vector types
-
float_extras
Extra floating-point math functions from C math library
-
connect-four-solver
A strong and perfect connect four solver in Rust
-
faer-svd
Basic linear algebra routines
-
complex_algebra
supporting complex number algebra
-
overflow-proof
Monadic checked arithmetic for Rust
-
candle-gemm-common
Playground for matrix multiplication algorithms
-
rsm-lib
A mathematics library for Rust, providing support for vector, matrix, and scalar operations
-
rl_ball_sym
Rocket League's ball physics
-
rust-fixed-point-decimal
Decimal fixed-point arithmetic
-
dashu-base
Common trait definitions and tools for the
dashu
libraries -
container-broadcast
analog of Julia's broadcast interface
-
inexor-rgf-model-arithmetic
Inexor - Reactive Graph Flow - Model - Arithmetic
-
num_vector
Enabling basic vector arithmetic operations
-
numerous
A set of tools to finding and classifying special numbers
-
gep
gep
, a better pointer arithmetic library -
superlu-sys
The package provides bindings to SuperLU
-
bitslice
transpose bits into and out of bitslice format, and perform various operations on bitsliced data
-
sv4state
SystemVerilog 4-state value library
-
nimble-client-connecting
Nimble Connecting Logic
-
lat
easy matrix manipulation on a component wise level - no linear algebra
-
matrix_kit
An abstract linear algebra library for Rust
-
quick_maths
low-dimensional linear algebra structures
-
float_approx_math
A math library for compile-time floating-point approximations (sqrt, sin, cos, etc...)
-
lyndon
Generate Lyndon words in lexicographic order
-
osqp-rust-sys
c2rust(osqp-sys)
-
softfp
Software floating point operation library
-
complexible
A minimal and user-friendly Rust library complex-number operations, bringing the joy of complex mathematics to Rustaceans everywhere!
-
cruncher
jit-compiled mathematical expression calculator
-
biconnected-components
Find biconnected components in a graph
-
ramp-primes
Generating Large Prime and Composite Numbers using ramp with a simplistic interface
-
pandas_rs
General Mathematics Library for Rust,Inspired by Python Pandas Library
-
calcrs
A command-line calculator with everything you need
-
strafe-error
Error types for strafe
-
big-num-manager
Rust big num manager
-
rustiny_linear_algebra
tiny linear algebra
-
differential-geometry
differential-geometric calculations
-
geom
2D geometry library
-
geomath
Stack-allocated maths for geometry, simulation and computer graphics
-
geo-aid-figure
Definitions for Geo-AID's JSON export format
-
floatd
just num_traits::Float + Debug + Display
-
delsum-poly
NTL bindings for the delsum crate
-
mathkid
Maths questions for kids
-
relation
based on the mathematical concept of financial relations
-
val_unc
A package for handling quantities with uncertainties
-
sort_rust
sort for Rust
-
melius-vectors
2-4 dimensional vectors that can be easily created and manipulated
-
numrs
A numerical computations library for Rust
-
linalgz
linear algebra library for Rust
-
graphrs
package for the creation, manipulation and analysis of graphs
-
gemm-f16
Playground for matrix multiplication algorithms
-
ak_arith_crate
perform arithmetic operations on i32 data type instance
-
miscmath
will be a collection of general math functions and linear algebra structures like vectors and matrices
-
safe_decimal
that solves the recurring decimal problem with fractions
-
m61-modulus
Functions for performing arithmetic modulo the 61st Mersenne number. Aimed at testing bignum implementations.
-
mini-kanren
miniKANREN in Rust
-
bigfloppa
Arbitrary precision decimal numbers
-
polenta
A toy language about polynomials over finite-fields
-
cat_solver
Rust bindings for the Kissat SAT solver
-
advancedresearch/boolean_paths
A research project in path semantics, a re-interpretation of functions for expressing mathematics
-
openblas-build
The package provides a build helper for OpenBLAS
-
razor-chase
implements a variation of The Chase algorithm to find models for theories in geometric form
-
fishers_exact
Fisher's exact statistical test
-
rustlinalg
linear algebra crate to support crustacea ML crate
-
swnb-complex
complex number lib
-
cryptix-bigint
A bigint library for cryptix
-
finitefields
Perform algebraic operations between integers over a finite field
-
math_l
Math Functions for LeetCode
-
cellular_env
An enviroment for simulation of physical systems (and possibly general purpose computation) using cellular automata, written in Rust
-
fastnoise_simd_bindings
Bindings for the FastNoiseSIMD library, https://github.com/Auburns/FastNoise
-
yew-katex
Render math with KaTeX in Yew!
-
rpni
A basic command-line RPN calculator
-
soy
Interpolation library
-
algebrust
basic linear algebra operations
-
mdmath
Multidimensional math
-
ldl
LDL factorisation for quasi-definite linear systems
-
wilson
Calculate Wilson confidence interval for binomial distribution using the formula from Wikipedia
-
nutils-poly
Low-level functions for evaluating and manipulating polynomials
-
cuba
wrapper for the C Cuba integration library
-
ffts
Rust binding for ffts (The Fastest Fourier Transform in the South)
-
dual_quaternion
A type-agnostic dual-quaternion math library
-
antic-sys
Bindings to the Antic library
-
vec_arith
Powerful vector/matrix arithmetic library written in Rust
-
time_series_utils
handling time series data
-
xcomplex
A complex number library
-
line-graph
Construct the line graph of an undirected graph
-
closure_calculus
Closure Calculus
-
primeshor
project to explore prime numbers and factorization
-
lagrangian_interpolation
An algorithm to interpolate between points with polynomials
-
num-rug-adapter
An adapter to use num crate where rug is needed
-
ig_learn_rust
Basic math operations
-
polynomial-ring
A polynomial implementation
-
aryth
a iterable toolset
-
cellular
command-line based cellular automaton animation creator
-
cargo_calc
calculation lib
-
p3-mds
Plonky3 MDS matrix logic
-
scirust
A scientific computing library
-
fractl_gui
Fractal renderer supporting multithreading, gpu compute and wasm
-
RustQuant_utils
quantitative finance
-
spokes
A network and network flow library
-
inti25_rust_lib1
Rust example by inti25
-
nonscalar
Functions and types for operating on nonscalar values like vectors and complex numbers
-
cw-bigint
Big integer implementation for Rust
-
jyafn
Computational graphs for Data Science that compile to machine code
-
vmd-rs
Variational Mode Decomoposition in Rust
-
dices
calculate discrete probability distributions and statistics for combinations of dices
-
vex
3D math library
-
simple_calculator
First Library
-
fj-window
Early-stage b-rep CAD kernel
-
logical_gate
A logic gate crate
-
pakr-iec
Functions to format numbers as decimal (1000 is 1.0k) and IEC (1024 is 1.0ki) up to YOTTA suffix
-
usagi
Common algorithms and utilities library for Rust
-
clamped
clamping of numbers in Rust
-
samplers
Sample from distributions and calculate summary statistics from the command line
-
blasoxide
BLAS implementation in rust
-
rgla
A linear algebra library for graphics that implements rotors instead of quaternions
-
malachite-float
The arbitrary-precision floating-point type Float, with efficient algorithms partially derived from MPFR
-
matrix-simp
A linear algebra package (WIP)
-
calcium-oxide
Calc-ium Oxide, a simple stack based command line calculator written in rust
-
arcs
An extensible framework for creating 2D CAD applications using the Entity-Component-System pattern
-
rusty-rubik
providing interaction and solvers for the Rubik's Cube
-
expy
Embeddable & extensible expression evaluator
-
C4lc
A program to help you access the public functions in this code and to perform mathematical calculations, including addition, subtraction, multiplication and division
-
intervals-good
An interval arithmetic library with support for many functions and which tracks when domain errors may occur or are guaranteed to occur
-
hyperoperation
(sometimes known as Knuth's notation) calculation library for Rust
-
tiago_functions
Algumas funções para uso externo
-
zernike
Routines to compute the Zernike polynomials
-
mop-common
Common definitions for MOP crates
-
peroxide-num
Numerical traits for Peroxide
-
nova-math
Vector and matrix math utilities for nova-engine
-
sphrs
Spherical harmonics and solid harmonics
-
elementwise
operations implemented for standard Rust containers
-
vecs
Vector Math Crate
-
matrix-basic
very basic matrix operations
-
last_order_logic
An experimental logical language
-
primality
Check if a number is prime
-
rapier3d-stl
STL file loader for the 3D rapier physics engine
-
hypertask_engine
The core logic engine used to run hypertask
-
mkl-rs-sys
MKL bindings for Rust
-
gramit
32-bit floating-point graphics math
-
coordinates
no nonsense, library for using two and three dimensonal coordinates in several systems
-
pop-prob-cli
A population probability calculator
-
math_rust
A Math library for vectors
-
si_units
handling arithmetic with SI units
-
arithmetic_parser_kma
Arithmetic expression calculator parser
-
polynomials
Tools to perform polynomial arithmetic and evaluation
-
math-crate
A libary for doing simple calculations in Rust
-
linalgo_structs
Objects available to the linalgo library
-
inertia-algebra
Abstract algebra for Rust
-
ema
using exponential moving averages
-
mex
A maths expression parser/evaluator
-
gml
Graphics Math Library. Generic Vector and Matrix Math library targetting graphics applications.
-
primenumbe-rs
Generate the nth prime number
-
random-partition
Generate approximately uniformly distributed random integer partitions
-
most_used_functions
most used fuctions such as input , mathematical operations
-
rust_estudo
Basic math operations
-
dihedral
(torsion) angle calculations
-
alga
Abstract algebra for Rust
-
geo-aid-dbg
A debugger for Geo-AID. Used in development for peeking inside Geo-AID in order to see how the generation process goes.
-
wright_omega
Wright Omega function
-
mini-c-ares-src
Source of c-ares and logic to build it using cmake
-
faer-qr
Basic linear algebra routines
-
simple_3d_vector
three-dimensional vectors in Rust
-
lodestone_python
User friendly magnetic field calculations in Rust
-
matrix
The package provides a matrix laboratory
-
relations
A lightweight library for working with mathematical binary relations
-
elr_primes
prime number iterator and methods for basic calculations with prime numbers
-
play-rsa
RSA cryptography in Rust for pedagogical use
-
discrete_transforms
Discrete Transforms
-
truncnorm
Normal and Truncated Normal distributions
-
routrs_highways_dataset
Highways dataset for routrs, the geograph-based shortest distance calculator for Rust
-
prime-data
Prime Number Data Library
-
projective
The representation projective transformation
-
df-maths
maths
-
arithmetic_parser_smetaniuk
Arithmetic expression calculator parser
-
piston3d-construct
higher order functional programming with homotopy maps to construct 3D geometry
-
point_like
Traits for 2D point-like types
-
math_utils_lib
providing math utilities such as a parser/evaluator and a LaTeX export to export a history of parsed expressions and solved equations to LaTeX
-
amfnbatch
Amortization Functions (AmFn) Batch Process
-
core-math-sys
Generate bindings to CORE-MATH
-
is_signed_trait
Trait for IS_SIGNED associated constant
-
dd_maths_traits
Strongly recommended to avoid using while in development. No semver guarantees.
-
pytha_calc
command-line Pythagorean Theorem calculator
-
numbrs
A flexible numerical computing package
-
mersenne-prime-number-miller-rabin
This package provides function to generate Mersenne number and test primality with Miller-Rabin Algorithme
-
bdrk_geometry
Geometry Helpers
-
mish
A proof of concept Rust libm like implementation with almost full coverage of libm
-
emath
Minimal 2D math library for GUI work
-
bigdecimal-no-std
Arbitrary precision decimal numbers
-
facto
Integer factorization and prime certification
-
mathop
math operations
-
slvs
Rust wrapper for the SolveSpace constraint solver library
-
arkley_traits
several traits for common mathematical operations
-
complex-stuff
working with complex numbers in rust
-
junglefowl
Brutally murdering Rust's type system one proof at a time
-
polynomials_pro
pro-level polynomials
-
bevy_hexasphere
A trimmed down and generic version of Hexasphere for bevy
-
ImtiazGermain
that checks if a number is a Germain and Imtiaz-Germain prime or not
-
pow_of_2
Integer-like types which can only represent powers of 2
-
modutil
Provide the methods supports modular arithmetic
-
logic-circus
Open source logic circuit simualtor written in Rust
-
arrow-arith
Arrow arithmetic kernels
-
linea
Linear Algebra: Vectors and Matrices
-
robust-geo
floating-point expansions and geometric tests (https://people.eecs.berkeley.edu/~jrs/papers/robustr.pdf)
-
logic-long
Supercell's Logic Long implemented in Rust
-
inta
Interval arithmetic in Rust
-
mtrx
type-safe matrix operations using const generics
-
linalg-rs
Linear algebra in Rust!
-
babalcore
Babal core logic library, low-level things which are game-engine agnostic
-
prime-portraits
A program that turns images into prime numbers
-
bootstrap-ht
Bootstrap Hypothesis Testing
-
cgmatrix
matrix library for computer graphics in Rust
-
bigint-base10
Experimental API for dealing with big integers in base-ten
-
sp2
2D geometric algebra spatial transforms and movement representations
-
lapacke
The package provides wrappers for LAPACKE (C)
-
random-distributions-cli
generate samples from various random distributions, as a text lines or a binary stream. Includes a general form of Stable distribution.
-
concurrent_prime_sieve
Tools for generating filters and collections with primes concurrently. Rust implementation of the Sieve of Atkin. This implementation runs in O( sqrt(max_num) + section_size ) (where section_size = max_num - min_num)…
-
sciport-rs
Rust port of scipy
-
cnfgen-nand-opt
Generate CNF for circuits
-
faer-lu
Basic linear algebra routines
-
primal-estimate
State-of-the-art estimation of upper and lower bounds for π(n) (the number of primes below n) and p_k (the k-th prime)
-
fructose
Mathematical Traits for the Glucose Library and the Rust programming language
-
tg-sys
unsafe low-level bindings to the
tg
geometry library -
g_calc
A small utility for performing simple math calculations using infix expression
-
viewp
A program is get any argument, that generates prime. it argument be number. This Program is Test Stage.
-
fj-viewer
Early-stage b-rep CAD kernel
-
concrete-fftw-sys
Sources of FFTW and unsafe binding
-
polynomical
tiny polynomial manipulation library
-
r2rs-stats
Statistics programming for Rust based on R's stats package
-
nines
9-Slice scaling math
-
candle-gemm
Playground for matrix multiplication algorithms
-
math-util
providing miscellaneous mathematical utility functions
-
rcomplex
class for manipulating complex numbers. This project is mainly for educational purposes, and I reccomend using other more complete packages for complex math.
-
dynisland-core
Common logic and widgets for dynisland modules and layout managers
-
binary_matrix
Dense binary matrix operations
-
alpha_stable
Sample and generate probability distribution functions of Alpha-Stable distributions in Rust
-
ComplexNumbers
performing operations on complex numbers in which the magnitude of the real and imaginary parts are provided in f64 datatype
-
exact-conv
Exact conversions between integer and floating point types
-
reform
A symbolic manipulation toolkit which aims to handle expressions with billions of terms, taking up terabytes of diskspace
-
polynom
handling polynomials
-
statistical-tests-rs
Statistical Tests for Rust
-
rprime
useful functions for prime numbers
-
simple-vectors
dimension generic vector math
-
fractran
execute Fractran programs
-
safeeft
Safe and branchless error-free transformation algorithms for floating point numbers
-
r_mathlib
A port of R’s
nmath
stats module to Rust -
const_ops
const-ready version of core::ops / std::ops arithmetic traits
-
rust-gmp
Rust bindings for GMP
-
acme-macros
Acme aims to provide a solid foundation for developing robust machine-learning systems in Rust
-
deterministic-trigonometry
Trigonometry without floating point variables to achieve deterministic results across hardware and compilers
-
primality-test
Primality Test crate
-
new_project
Basic math operations
-
noah-plonk
Noah TurboPLONK protocol
-
horner-eval
A macro for evaluating polynomials via Horner's rule
-
pendragon
Easy polygon drawing built on top of lyon
-
complex-plane
complex numbers and their associated operations in the complex plane
-
code_abinash
A collection of utilities to make performing certain calculations more convenient
-
time_varying_graph
A complex graph package for interacting with time-varying graphs. For more information you can check out https://arxiv.org/abs/1012.0009
-
rust_combinatorics
Combinatoric utilities and functions for rust
-
qalqulator
A calculator that uses (and outputs) rational numbers wherever possible
-
cronbach_alpha_lib
get cronbach alpha value to check your reliable question
-
advancedresearch/path_semantics-sym_extract
A research project in path semantics, a re-interpretation of functions for expressing mathematics
-
logic-lang
structural logic based on equivalence graphs
-
polynomial_ops
Multivariable polynomial operations on arrays and vectors
-
num-consts
General-purpose mathematical constants
-
glucose
multipurpose math and physics crate for my projects
-
statc
essentially a TI-84 extended, geared towards statistical calculations and making data easily readable and obtainable
-
arkley
several traits for common mathematical operations
-
superlu
The package provides an interface to SuperLU
-
dfkzr
Dezimalfestkommazahlrechnung - decimal fixed point arithmetic with up to 19 digits
-
blend-formula
macros for defining GPU blend modes from arbitrary formulae
-
guff-sharefiles
Package IDA-encoded data in a portable file format
-
anomalocaris
Rust Armadillo wrapper
-
nt-primes
Recreational mathematics crate for various forms of primes
-
gemm-common
Playground for matrix multiplication algorithms
-
curve_similarities
Calculation of curve similarities for 2-dimensional arrays
-
prime_gen
Generate prime numbers
-
polynomial_tools
that contains some utilities for operations on polynomials
-
lodestone_core
User friendly magnetic field calculations in Rust
-
cg-lab
A computer graphics tool for teaching and research
-
fftw-src
Source of FFTW
-
spfunc
numerical calculation of special functions
-
fj-operations
Early-stage, next-generation, code-first CAD application. Because the world needs another CAD program.
-
yara-src
Source of VirusTotal's YARA and logic to build it
-
gemm-c64
Playground for matrix multiplication algorithms
-
nano-gemm
Small matrix multiplication
-
nzscq
Core logic for NZSCQ
-
polynomint
A no-dependency library for working with integer polynomials
-
fuzzy-expert
A fuzzy logic library with support for mamdani fuzzy inference
-
netlib-provider
The package provides BLAS and LAPACK using the Netlib implementation
-
trinary
Rust types for trinary logic
-
rug-miller-rabin
A multi-threaded, arbitrary precision implementation of the Miller-Rabin primality test using rug (GMP)
-
faer-entity
Basic linear algebra routines
-
prime-number-utils
generate prime numbers and to determine whether a number is prime efficiently
-
euphony-mix
mixing logic for euphony compositions
-
numeric_constant_traits
Traits for generic numeric constants
-
rug-fft
FFT implementations for rug integers
-
fuzzylogic
operations for fuzzy set theory
-
arkley_numerics
This module provides various number representations and calculations that represent several structs and enums that represent common mathematical numbers such as fractions, standard form, and decimals,
-
static_linear_algebra
A static linear algebra library where size compatibility of operations are checked at compile time
-
num-irrational
num-irrational
is based onnum
and extends it with support for several kinds of irrational numbers -
onay_stat
calculating sum, mean, median, median but sorted, range, variance, standard deviation, mode, max and min value and their indices
-
matext4cgmath
Unofficial third-party cgmath extensions for calculate eigenvalues, operator norms and Iwasawa decomposition
-
geo-aid-json
Support for JSON output from Geo-AID
-
poly_log
working with polynomials
-
chikage
easy to understand and barebones math library for game and graphics development
-
rlwe
Arithmetic in RLWE rings
-
gon
Easy polygon drawing built on top of lyon
-
bellperson-emulated
Nonnative arithmetic library using bellperson inspired by the emulated package in Gnark
-
lineas
A mathematical linear algebra library for Rust
-
goldilocks-ntt
fast NTTs over the Goldilocks prime field
-
primal-bit
Bit-vector specialised to the prime-number-related needs of
primal
-
primeish
A CLI containing various prime number utilities
-
shanksbot-rs
ShanksBot shown by Matt Parker in https://www.youtube.com/watch?v=DmfxIhmGPP4
-
sophus_tensor
sophus - geometry for robotics and computer vision
-
ezcgmath
Easy linear algebra Math library for use with computer graphics
-
prime-iter
An incremental-sieve based prime generator
-
vector_math_first_lib
vector math
-
prim
find prime numbers
-
information
theory functions to use with ndarray
-
bubblemath
A collection of mathematical algorithms in pure Rust
-
factorprime
finding whether a number is prime or not and also determine its factors
-
libbytestat
Randomness analyzer
-
ludomath
A math library for 2D games and graphics
-
cplx
Complex and hypercomplex numbers
-
sirp
Computing properties of factorials, k-factorials and SIRPs
-
tinymath
Experimental routines for performing arithmetic on small data types
-
fixed
Fixed-point numbers
-
accelerate-src
The package provides a source of BLAS and LAPACK via the Accelerate framework
-
prime_tools
Generate primes, get prime factors, check primality, and other useful prime-related utilities
-
gated-development
Pedagogical implementation of command line calculator using basic logic gates
-
sna
Serial Number Arithmetic (RFC 1982) for Rust
-
gfxmath-vec4
3D math library
-
simple-si-units-core
shared dependencies for crate simple-si-units
-
cyclic
complete, and dependency-free modular arithmetic
-
fj-host
Early-stage, next-generation, code-first CAD application. Because the world needs another CAD program.
-
simpler_vector
a very simple library for 2d/3d vector math
-
red_primality
zero-setup primality testing and factoring for all u64
-
strafe-testing
Testing framework for strafe
-
hypersphere
4D primitives for rotation and projection
-
poly
Generic dense polynomials
-
poseidon-paramgen
generating Poseidon parameters
-
bigdecimal-rs
Arbitrary precision decimal numbers
-
horner
Evaluate polynomials using Horner's method
-
gemm-f32
Playground for matrix multiplication algorithms
-
fftw3
Bindings to FFTW3: the Fastest Fourier Transform in the West. This library aims to expose the full power of FFTW3 in high-performance, safe and idiomatic manner. NB. FFTW3 is licensed GPLv2 (or later)…
-
strafe-type
Types for strafe
-
same-as
Type equality in stable Rust
-
physsol
Lightweight 2d and 3d physics library
-
rust-gmp-serde
Rust bindings for GMP, added serde support
-
fastdiv
Perform fast division by a runtime constant
-
logiclong
Supercell's Logic Long implemented in Rust
-
blas-sys
The package provides bindings to BLAS (Fortran)
-
calculator_101
contains modules to perform basic arithmetic operation
-
next_prime
A function that returns the next prime greater than or equal to its argument