Code
Results

Quick Reference

The Calcpad language includes the following elements (click an item to insert):

Real numbers: digits "0" - "9" and decimal point ".";

Complex numbers: re ± imi (e.g. 3 - 2i);

Variables:

- Latin letters a - z, A - Z;
- Greek letters α - ω, Α - Ω;
- digits 0 - 9;
- comma ",";
- special symbols: , , , , , ø , Ø , ° , ;
- superscripts: ⁰ , ¹ , ² , ³ , ⁴ , ⁵ , ⁶ , ⁷ , ⁸ , ⁹ , ⁿ , ⁺ , ⁻ ;
- subscripts: ₀ , ₁ , ₂ , ₃ , ₄ , ₅ , ₆ , ₇ , ₈ , ₉ , ₊ , ₋ , ₌ , ₍ , ₎ ;
- superscripts: ⁰ , ¹ , ² , ³ , ⁴ , ⁵ , ⁶ , ⁷ , ⁸ , ⁹ , ⁿ , ⁺ , ⁻ ;
- " _ " for subscript;
A variable name must start with a letter. Names are case sensitive.

Constants: π, e, φ, γ, g, G, ME, MS, c, h, μ0, ε0, ke, e, me, mp, mn, NA, σ, kB, R, F, γc, γs, γa, γg, γw;

Operators:

"!" - factorial;
"^" - exponent;
"/" - division;
"÷" - force division bar;
"\" - division;
"" - modulo (reminder);
"*" - multiplication;
"-" - minus;
"+" - plus;
"" - equal to;
"" - not equal to;
"<" - less than;
">" - greater than;
"" - less or equal;
"" - greater or equal;
"" - logical "AND";
"" - logical "OR";
"" - logical "XOR";
"" - phasor A∠φ (<<);
"=" - assignment;

Custom functions of type f (x; y; z; ...);
Built-in functions:

Trigonometric:
sin(x) - sine;
cos(x) - cosine;
tan(x) - tangent;
csc(x) - cosecant;
sec(x) - secant;
cot(x) - cotangent;
Hyperbolic:
sinh(x) - hyperbolic sine;
cosh(x) - hyperbolic cosine;
tanh(x) - hyperbolic tangent;
csch(x) - hyperbolic cosecant;
sech(x) - hyperbolic secant;
coth(x) - hyperbolic cotangent;
Inverse trigonometric:
asin(x) - inverse sine;
acos(x) - inverse cosine;
atan(x) - inverse tangent;
atan2(x; y) - the angle whose tangent is the quotient of x and y;
acsc(x) - inverse cosecant;
asec(x) - inverse secant;
acot(x) - inverse cotangent;
Inverse hyperbolic:
asinh(x) - inverse hyperbolic sine;
acosh(x) - inverse hyperbolic cosine;
atanh(x) - inverse hyperbolic tangent;
acsch(x) - inverse hyperbolic cosecant;
asech(x) - inverse hyperbolic secant;
acoth(x) - inverse hyperbolic cotangent;
Logarithmic, exponential and roots:
log(x) - decimal logarithm;
ln(x) - natural logarithm;
exp(x) - natural exponent = eˣ;
log_2(x) - binary logarithm;
sqrt(x) - square root;
cbrt(x) - cubic root;
root(x; y) - n-th root;
Rounding:
round(x) - round to the nearest integer;
floor(x) - round to the lower integer;
ceiling(x) - round to the greater integer;
trunc(x) - round to the nearest integer towards zero;
Integer:
mod(x) - the reminder of an integer division;
gcd(x) - the greatest common divisor of two integers;
lcm(x) - the least common multiple of two integers;
Complex:
abs(x) - absolute value/magnitude;
re(x) - the real part of a complex number;
im(x) - the imaginary part of a complex number;
phase(x) - the phase of a complex number;
conj(x) - the conjugate of a complex number;
Aggregate and interpolation:
min(x; y; z...) - minimum of multiple values;
max(x; y; z...) - maximum of multiple values;
sum(x; y; z...) - sum of multiple values = x + y + z...;
sumsq(x; y; z...) - sum of squares = x² + y² + z²...;
srss(x; y; z...) - square root of sum of squares = sqrt(x² + y² + z²...);
average(x; y; z...) - average of multiple values = (x + y + z...)/n;
product(x; y; z...) - product of multiple values = x·y·z...;
mean(x; y; z...) - geometric mean = n-th root(x·y·z...);
take(n; a; b; c...) - returns the n-th element from the list;
line(x; a; b; c...) - linear interpolation;
spline(x; a; b; c...) - Hermite spline interpolation; Conditional and logical:
if(<cond>; <value-if-true>; <value-if-false>) - conditional evaluation;
switch(<cond1>; <value1>; <cond2>; <value2>;...; <default>) - selective evaluation;
not(x - logical "not";
and(x; y; z...) - logical "AND";
or(x; y; z...) - logical "OR";
xor(x; y; z...) - logical "XOR";
Other:
sign(x) - sign of a number;
random(x) - a random number between 0 and x;
getunits(x) - gets the units of x without the value. Returns 1 if x is unitless;
setunits(x; u) - sets the units u to x where x can be scalar, vector or matrix;
clrunits(x) - clears the units from a scalar, vector or matrix x;
hp(x) - converts x to its high performance (hp) equivalent type;
ishp(x) - checks if the type of x is a high-performance (hp) vector or matrix;
Vector:
 Creational:
  vector(n) - creates an empty vector with length n;
  vector_hp(n) - creates an empty high performance (hp) vector with length n;
  range(x1; xn; step) - creates a vector with values spanning from x1 to xn with step step;
  range_hp(x1; xn; step) - creates a high performance (hp) from a range of values as above;
 Structural:
  len(v) - returns the length of vector v;
  size(v) - the actual size of vector v (the index of the last non-zero element);
  resize(v; n) - sets a new length n of vector v;
  fill(v; x) - fills vector v with value x;
  join(M; v; x…) - creates a vector by joining the arguments: matrices, vectors and scalars;
  slice(v; i1; i2) - returns the part of vector v bounded by indexes i1 and i2 inclusive;
  first(v; n) - the first n elements of vector v;
  last(v; n) - the last n elements of vector v;
  extract(v; vi) - extracts the elements from v which indexes are contained in vi;
 Data:
  sort(v) - sorts the elements of vector v in ascending order;
  rsort(v) - sorts the elements of vector v in descending order;
  order(v) - the indexes of vector v, arranged by the ascending order of its elements;
  revorder(v) - the indexes of vector v, arranged by the descending order of its elements;
  reverse(v) - a new vector containing the elements of v in reverse order;
  count(v; x; i) - the number of elements in v, after the i-th one, that are equal to x;
  search(v; x; i) - the index of the first element in v, after the i-th one, that is equal to x;
  find(v; x; i) or
  find_eq(v; x; i) - the indexes of all elements in v, after the i-th one, that are = x;
  find_ne(v; x; i) - the indexes of all elements in v, after the i-th one, that are ≠ x;
  find_lt(v; x; i) - the indexes of all elements in v, after the i-th one, that are < x;
  find_le(v; x; i) - the indexes of all elements in v, after the i-th one, that are ≤ x;
  find_gt(v; x; i) - the indexes of all elements in v, after the i-th one, that are > x;
  find_ge(v; x; i) - the indexes of all elements in v, after the i-th one, that are ≥ x;
  lookup(a; b x) or
  lookup_eq(a; b; x) - all elements in a for which the respective elements in b are = x;
  lookup_ne(a; b; x) - all elements in a for which the respective elements in b are ≠ x;
  lookup_lt(a; b; x) - all elements in a for which the respective elements in b are < x;
  lookup_le(a; b; x) - all elements in a for which the respective elements in b are ≤ x;
  lookup_gt(a; b; x) - all elements in a for which the respective elements in b are > x;
  lookup_ge(a; b; x) - all elements in a for which the respective elements in b are ≥ x;
 Math:
  norm_1(v) - L1 (Manhattan) norm of vector v;
  norm(v) or
  norm_2(v) or
  norm_e(v) - L2 (Euclidean) norm of vector v;
  norm_p(v; p) - Lp norm of vector v;
  norm_i(v) - L∞ (infinity) norm of vector v;
  unit(v) - the normalized vector v (with L2 norm = 1);
  dot(a; b) - scalar product of two vectors a and b
  cross(a; b) - cross product of two vectors a and b (with length 2 or 3);
Matrix:
 Creational:
  matrix(m; n) - creates an empty matrix with dimensions mn;
  identity(n) - creates an identity matrix with dimensions nn;
  diagonal(n; d) - creates a nn diagonal matrix and fills the diagonal with value d;
  column(m; c) - creates a column matrix with dimensions m⨯1, filled with value c;
  utriang(n) - creates an upper triangular matrix with dimensions nn;
  ltriang(n) - creates a lower triangular matrix with dimensions nn;
  symmetric(n) - creates a symmetric matrix with dimensions nn;
  matrix_hp(m; n) - creates a high-performance matrix with dimensions mn;
  identity_hp(n) - creates a high-performance identity matrix with dimensions nn;
  diagonal_hp(n; d) - creates a high-performance nn diagonal matrix filled with value d;
  column_hp(m; c) - creates a high-performance m⨯1 column matrix filled with value c;
  utriang_hp(n) - creates a high-performance nn upper triangular matrix;
  ltriang_hp(n) - creates a high-performance nn lower triangular matrix;
  symmetric_hp(n) - creates a high-performance symmetric matrix with dimensions nn;
  vec2diag(v) - creates a diagonal matrix from the elements of vector v
  vec2row(v) - creates a row matrix from the elements of vector v;
  vec2col(v) - creates a column matrix from the elements of vector v;
  join_cols(c1; c2; c3…) - creates a new matrix by joining column vectors;
  join_rows(r1; r2; r3…) - creates a new matrix by joining row vectors;
  augment(A; B; C…) - creates a new matrix by appending matrices A; B; C side by side;
  stack(A; B; C…) - creates a new matrix by stacking matrices A; B; C one below the other;
 Structural:
  n_rows(M) - number of rows in matrix M;
  n_cols(M) - number of columns in matrix M;
  mresize(M; m; n) - sets new dimensions m and n for matrix M;
  mfill(M; x) - fills matrix M with value x;
  fill_row(M; i; x) - fills the i-th row of matrix M with value x;
  fill_col(M; j; x) - fills the j-th column of matrix M with value x;
  copy(A; B; i; j) - copies all elements from A to B, starting from indexes i and j of B;
  add(A; B; i; j) - adds all elements from A to those of B, starting from indexes i and j of B;
  row(M; i) - extracts the i-th row of matrix M as a vector;
  col(M; j) - extracts the j-th column of matrix M as a vector;
  extract_rows(M; vi) - extracts the rows from matrix M whose indexes are contained in vector vi;
  extract_cols(M; vj) - extracts the columns from matrix M whose indexes are contained in vector vj;
  diag2vec(M) - extracts the diagonal elements of matrix M to a vector;
  submatrix(M; i1; i2; j1; j2) - extracts a submatrix of M, bounded by rows i1 and i2 and columns j1 and j2, incl.;
 Data:
  sort_cols(M; i) - sorts the columns of M based on the values in row i in ascending order;
  rsort_cols(M; i) - sorts the columns of M based on the values in row i in descending order;
  sort_rows(M; j) - sorts the rows of M based on the values in column j in ascending order;
  rsort_rows(M; j) - sorts the rows of M based on the values in column j in descending order;
  order_cols(M; i) - the indexes of the columns of M based on the ordering of the values from row i in ascending order;
  revorder_cols(M; i) - the indexes of the columns of M based on the ordering of the values from row i in descending order;
  order_rows(M; j) - the indexes of the rows of M based on the ordering of the values in column j in ascending order;
  revorder_rows(M; j) - the indexes of the rows of M based on the ordering of the values in column j in descending order;
  mcount(M; x) - number of occurrences of value x in matrix M;
  msearch(M; x; i; j) - vector with the two indexes of the first occurrence of x in matrix M, starting from indexes i and j;
  mfind(M; x) or
  mfind_eq(M; x) - the indexes of all elements in M that are = x;
  mfind_ne(M; x) - the indexes of all elements in M that are ≠ x;
  mfind_lt(M; x) - the indexes of all elements in M that are < x;
  mfind_le(M; x) - the indexes of all elements in M that are ≤ x;
  mfind_gt(M; x) - the indexes of all elements in M that are > x;
  mfind_ge(M; x) - the indexes of all elements in M that are ≥ x;
  hlookup(M; x; i1; i2) or
  hlookup_eq(M; x; i1; i2) - the values from row i2 of M, for which the elements in row i1 are = x;
  hlookup_ne(M; x; i1; i2) - the values from row i2 of M, for which the elements in row i1 are ≠ x;
  hlookup_lt(M; x; i1; i2) - the values from row i2 of M, for which the elements in row i1 are < x;
  hlookup_le(M; x; i1; i2) - the values from row i2 of M, for which the elements in row i1 are ≤ x;
  hlookup_gt(M; x; i1; i2) - the values from row i2 of M, for which the elements in row i1 are > x;
  hlookup_ge(M; x; i1; i2) - the values from row i2 of M, for which the elements in row i1 are ≥ x;
  vlookup(M; x; j1; j2) or
  vlookup_eq(M; x; j1; j2) - the values from column j2 of M, for which the elements in column j1 are = x;
  vlookup_ne(M; x; j1; j2) - the values from column j2 of M, for which the elements in column j1 are ≠ x;
  vlookup_lt(M; x; j1; j2) - the values from column j2 of M, for which the elements in column j1 are < x;
  vlookup_le(M; x; j1; j2) - the values from column j2 of M, for which the elements in column j1 are ≤ x;
  vlookup_gt(M; x; j1; j2) - the values from column j2 of M, for which the elements in column j1 are > x;
  vlookup_ge(M; x; j1; j2) - the values from column j2 of M, for which the elements in column j1 are ≥ x;
 Math:
  hprod(A; B) - Hadamard product of matrices A and B;
  fprod(A; B) - Frobenius product of matrices A and B;
  kprod(A; B) - Kronecker product of matrices A and B;
  mnorm_1(M) - L1 norm of matrix M;
  mnorm(M) or
  mnorm_2(M) - L2 norm of matrix M;
  mnorm_e(M) - Frobenius norm of matrix M;
  mnorm_i(M) - L∞ norm of matrix M;
  cond_1(M) - condition number of M based on the L1 norm;
  cond(M) or
  cond_2(M) - condition number of M based on the L2 norm;
  cond_e(M) - condition number of M based on the Frobenius norm;
  cond_i(M) - condition number of M based on the L∞ norm;
  det(M) - determinant of matrix M;
  rank(M) - rank of matrix M;
  trace(M) - trace of matrix M;
  transp(M) - transpose of matrix M;
  adj(M) - adjugate of matrix M;
  cofactor(M) - cofactor matrix of M;
  eigenvals(M; ne) - the first ne eigenvalues of matrix M (or all if omitted);
  eigenvecs(M; ne) - the first ne eigenvectors of matrix M (or all if omitted);
  eigen(M; ne) - the first ne eigenvalues and eigenvectors of matrix M (or all if omitted);
  cholesky(M) - Cholesky decomposition of a symmetric, positive-definite matrix M;
  lu(M) - LU decomposition of matrix M;
  qr(M) - QR decomposition of matrix M;
  svd(M) - singular value decomposition of M;
  inverse(M) - inverse of matrix M;
  lsolve(A; b) - solves the system of linear equations Ax = b using LDLT decomposition for symmetric matrices, and LU for non - symmetric;
  clsolve(A; b) - solves the linear matrix equation Ax = b with symmetric, positive-definite coefficient matrix A using Cholesky decomposition;
  slsolve(A; b) - solves the linear matrix equation Ax = b with high-performance symmetric, positive-definite matrix A using preconditioned conjugate gradient(PCG) method;
  msolve(A; B) - solves the generalized matrix equation AX = B using LDLT decomposition for symmetric matrices, and LU for non-symmetric;
  cmsolve(A; B) - solves the generalized matrix equation AX = B with symmetric, positive-definite coefficient matrix A using Cholesky decomposition;
  smsolve(A; B) - solves the generalized matrix equation AX = B with high-performance symmetric, positive-definite matrix A using preconditioned conjugate gradient (PCG) method;
  fft(M) - performs fast Fourier transform of row-major matrix M. It must have one row for real data and two rows for complex;
  ift(M) - performs inverse Fourier transform of row-major matrix M. It must have one row for real data and two rows for complex;
 Double interpolation:
  take(x; y; M) - returns the element of matrix M at indexes x and y;
  line(x; y; M) - double linear interpolation from the elements of matrix M based on the values of x and y;
  spline(x; y; M) - double Hermite spline interpolation from the elements of matrix M based on the values of x and y.
  Tol - target tolerance for the iterative PCG solver.

Comments: "Title" or 'text' in double or single quotes, respectively.
HTML, CSS, JS and SVG are allowed.

Graphing and plotting:

$Plot{ f(x) @ x = a : b } - simple plot;
$Plot{ x(t) | y(t) @ t = a : b } - parametric;
$Plot{ f1(x) & f2(x) & ... @ x = a : b } - multiple;
$Plot{ x1(t) | y1(t) & x2(t) | y2(t) & ... @ t = a : b } - multiple parametric;
$Map{ f(x; y) @ x = a : b & y = c : d } - 2D color map of a 3D surface;
PlotHeight - height of plot area in pixels;
PlotWidth - width of plot area in pixels;
PlotStep - the size of the mesh for map plotting;
PlotSVG - draw plots in vector (SVG) format;
PlotPalette - the number of color palette to be used for surface plots (0-8);
PlotShadows - draw surface plots with shadows;
PlotSmooth - smooth transition of colors (= 1) or isobands (= 0) for surface plots;
PlotLightDir - direction to light source (0-7) clockwise.

Iterative and numerical methods:

$Root{ f(x) = const @ x = a : b } - root finding for f(x) = const;
$Root{ f(x) @ x = a : b } - root finding for f(x) = 0;
$Find{ f(x) @ x = a : b } - similar to previous, but x is not required to be a precise solution;
$Sup{ f(x) @ x = a : b } - local maximum of a function;
$Inf{ f(x) @ x = a : b } - local minimum of a function;
$Area{ f(x) @ x = a : b } - numerical integration;
$Slope{ f(x) @ x = a } - numerical differentiation;
$Sum{ f(k) @ k = a : b } - iterative suM;
$Product{ f(k) @ k = a : b } - iterative product;
$Repeat{ f(k) @ k = a : b } - general inline iterative procedure;
Precision - relative precision for numerical methods [10-2; 10-16] (default is 10-12)

Program flow control:

Simple:
    #if <condition>
        <Your code here>
    #end if

Alternative:
    #if <condition>
        <Your code here>
    #else
        <Some other code>
    #end if

Complete:
    #if <condition1>
        <Your code here>
    #else if <condition2>
        <Your code here>
    #else
        <Some other code>
    #end if

You can add or omit as many "#else if's" as needed. Only one "#else" is allowed. You can omit this too.

Iteration blocks:

Simple:
    #repeat <number of repetitions>
        <Your code here>
    #loop

With conditional break:
    #repeat <number of repetitions>
        <Your code here>
        #if <condition>
            #break
        #end if
        <Some more code>
    #loop

Output control:

#hide - hide the report contents;
#show - always show the contents (default);
#pre - show the next contents only before calculations;
#post - show the next contents only after calculations;
#val - show only the calculated results;
#equ - show the complete equations (default);
#noc - show only equations without results (no calculations);
#nosub - do not substitute variables (no substitution);
#novar - show equations only with substituted values (no variables);
#varsub - show equations with variables and substituted values (default);
#split - split equations that do not fit on a single line;
#wrap - wrap equations that do not fit on a single line (default);
#round n - rounds the output to n digits after the decimal point;
#round default - restores rounding to the default settings;
#format FFFF - specifies custom format string;
#format default - restores the default formatting;
#md on - enables markdown in comments;
#md off - disables markdown in comments;
#phasor - sets output format of complex numbers to polar phasor: A∠φ;
#complex - sets output format of complex numbers to Cartesian algebraic: a + bi.
Each of the above commands is effective after the current line until the end of the report or another command that overwrites it.

Breakpoints for step-by-step execution:

#pause - calculates to the current line and waits until resumed manually;
#input - renders an input form to the current line and waits for user input.

Units for trigonometric functions: #deg - degrees, #rad - radians; #gra - grades;

Separator for target units: |;

Return angles with units: ReturnAngleUnits = 1;

Dimensionless units: %, ;

Angle units: °, , , deg, rad, grad, rev;

Metric units (SI and compatible):

Mass: g, hg, kg, t, kt, Mt, Gt, dg, cg, mg, μg, ng, pg, Da, u;
Length: m, km, dm, cm, mm, μm, nm, pm, AU, pm;
Time: s, ms, μs, ns, ps, min, h, d, w, y;
Frequency: Hz, kHz, MHz, GHz, THz, mHz, μHz, nHz, pHz, rpm;
Speed: kmh;
Electric current: A, kA, MA, GA, TA, mA, μA, nA, pA;
Temperature: °C, Δ°C, K;
Amount of substance: mol;
Luminous intensity: cd;
Area: a, daa, ha;
Volume: L, daL, hL, dL, cL, mL, μL, nL, pL;
Force: N, daN, hN, kN, MN, GN, TN, kgf, tf, dyn;
Moment: Nm, kNm;
Pressure: Pa, daPa, hPa, kPa, MPa, GPa, TPa,
     dPa, cPa, mPa, μPa, nPa, pPa,
     bar, mbar, μbar, atm, at, Torr, mmHg;
Viscosity: P, cP, St, cSt;
Energy work: J, kJ, MJ, GJ, TJ, mJ, μJ, nJ, pJ,
      Wh, kWh, MWh, GWh, TWh, mWh, μWh, nWh, pWh,
      eV, keV, MeV, GeV, TeV, PeV, EeV, cal, kcal, erg;
Power: W, kW, MW, GW, TW, mW, μW, nW, pW, hpM, ks,
    VA, kVA, MVA, GVA, TVA, mVA, μVA, nVA, pVA,
    VAR, kVA, MVA, GVA, TVA, mVA, μVA, nVA, pVA;
Electric charge: C, kC, MC, GC, TC, mC, μC, nC, pC, Ah, mAh;
Potential: V, kV, MV, GV, TV, mV, μV, nV, pV;
Capacitance: F, kF, MF, GF, TF, mF, μF, nF, pF;
Resistance: Ω, , , , , , μΩ, , ;
Conductance: S, kS, MS, GS, TS, mS, μS, nS, pS,
       , k℧, M℧, G℧, T℧, m℧, μ℧, n℧, p℧;
Magnetic flux: Wb, kWb, MWb, GWb, TWb, mWb, μWb, nWb, pWb;
Magnetic flux density: T, kT, MT, GT, TT, mT, μT, nT, pT;
Inductance: H, kH, MH, GH, TH, mH, μH, nH, pH;
Luminous flux: lm;
Illuminance: lx;
Radioactivity: Bq, kBq, MBq, GBq, TBq, mBq, μBq, nBq, pBq, Ci, Rd;
Absorbed dose: Gy, kGy, MGy, GGy, TGy, mGy, μGy, nGy, pGy;
Equivalent dose: Sv, kSv, MSv, GSv, TSv, mSv, μSv, nSv, pSv;
Catalytic activity: kat;

Non-metric units (Imperial/US):

Mass: gr, dr, oz, lb (or lbm, lb_m), klb (or kipm, kip_m), st, qr,
    cwt_UK, cwt_US, ton_UK, ton_US, slug;
Length: th, in, ft, yd, ch, fur, mi, ftm, ftm_UK, ftm_US,
    cable, cable_UK, cable_US, nmi, li, rod, pole, perch, lea;
Speed: mph, knot;
Temperature: °F, Δ°F, °R;
Area: rood, ac;
Volume, fluid: fl_oz_UK, gi_UK, pt_UK, qt_UK, gal_UK, bbl_UK,
       fl_oz_US, gi_US, pt_US, qt_US, gal_US, bbl_US;
Volume, dry: (US) pt_dry, (US) qt_dry, (US) gal_dry, (US) bbl_dry,
       pk_UK, pk_US, bu_UK, bu_US;
Force: ozf or (oz_f ), lbf or (lb_f ), kipf or (kipf, kip_f ), tonf or (ton_f ), pdl;
Pressure: osi, osf, psi, psf, ksi, ksf, tsi, tsf, inHg;
Energy work: BTU, therm_UK, therm_US, quad;
Power: hp, hpE, hpS.

Custom units - .Name = expression.
Names can include currency symbols: , £, , ¥, ¢, , , , .
















Powered by Calcpad v.7.4.1.0. Note: The web version does not support modules and macros. Matrices are limited to 1000x1000, and vectors to 10000 elements.

How does it work?

  1. Enter your formulas and text into the "Code" area on the left.
  2. Press Enter or click to calculate. The results will appear in the "Results" box on the right.
  3. Click "Preview" to preview and print the calculation notes.

You can use variables, functions and units of measurement in expressions, e.g.: 4cm + 3in. To convert to other units, add vertical bar "|" and target units at the end: 4cm|in.

The Calcpad language also supports complex numbers, custom functions, plotting, numerical methods, sums, products, conditional statements, iteration blocks, etc. Check our quick reference or the complete user manual.

Example:

"Quadratic equation example:
a = 3 ', ' b = 4 ', ' c = -5
f(x) = a*x^2 + b*x + c '= 0
'Discriminant - ' D = b^2 - 4*a*c
#if D < 0
    'D < 0. No real roots exist.'
    $Plot{f(x) @ x = -3 : 2}
#else
    x_1 = (-b - sqr(D))/(2*a)
    x_2 = (-b + sqr(D))/(2*a)
    $Plot{f(x) & x_1|0 & x_2|0 @ x = -3 : 2}
#end if