# This file is a part of Julia. License is MIT: http://julialang.org/license export # Modules FFTW, Meta, Operators, Pkg, LibGit2, StackTraces, Profile, Dates, Sys, Test, Libc, Libdl, Mmap, LinAlg, BLAS, LAPACK, Serializer, Docs, Markdown, Threads, Iterators, Parallel, # Types AbstractChannel, AbstractMatrix, AbstractSet, AbstractUnitRange, AbstractVector, AbstractVecOrMat, Array, Associative, Bidiagonal, BigFloat, BigInt, BitArray, BitMatrix, BitVector, BufferStream, CartesianIndex, CartesianRange, Channel, Cmd, Colon, Complex, Complex128, Complex64, Complex32, ConjArray, ConjVector, ConjMatrix, DenseMatrix, DenseVecOrMat, DenseVector, DevNull, Diagonal, Dict, Dims, EachLine, Enum, Enumerate, ExponentialBackOff, Factorization, FileMonitor, Hermitian, UniformScaling, IndexCartesian, IndexLinear, IndexStyle, InsertionSort, IntSet, IOBuffer, IOStream, LinSpace, LowerTriangular, Irrational, Matrix, MergeSort, NTuple, Nullable, ObjectIdDict, OrdinalRange, Pair, PartialQuickSort, PermutedDimsArray, PollingFileWatcher, QuickSort, Range, RangeIndex, Rational, Regex, RegexMatch, RevString, RoundFromZero, RoundDown, RoundingMode, RoundNearest, RoundNearestTiesAway, RoundNearestTiesUp, RoundToZero, RoundUp, RowVector, AbstractSerializer, SerializationState, Set, SharedArray, SharedMatrix, SharedVector, StepRange, StepRangeLen, StridedArray, StridedMatrix, StridedVecOrMat, StridedVector, SubArray, SubString, Symmetric, SymTridiagonal, Timer, Tridiagonal, UnitRange, UpperTriangular, Val, VecOrMat, Vector, VersionNumber, WeakKeyDict, # Ccall types Cchar, Cdouble, Cfloat, Cint, Cintmax_t, Clong, Clonglong, Cptrdiff_t, Cshort, Csize_t, Cssize_t, Cuchar, Cuint, Cuintmax_t, Culong, Culonglong, Cushort, Cwchar_t, Cstring, Cwstring, # Exceptions ArgumentError, DimensionMismatch, CapturedException, CompositeException, EOFError, ErrorException, InvalidStateException, KeyError, LoadError, InitError, MethodError, NullException, ParseError, SystemError, TypeError, AssertionError, UnicodeError, # Global constants and variables ARGS, C_NULL, ENDIAN_BOM, ENV, JULIA_HOME, LOAD_PATH, PROGRAM_FILE, STDERR, STDIN, STDOUT, VERSION, # Mathematical constants Inf, Inf16, Inf32, Inf64, NaN, NaN16, NaN32, NaN64, im, π, pi, e, eu, γ, eulergamma, catalan, φ, golden, I, # Operators !, !=, ≠, !==, ≡, ≢, xor, ⊻, %, ÷, &, *, +, -, /, //, <, <:, <<, <=, ≤, ==, >, >:, >=, ≥, >>, >>>, \, ^, |, |>, ~, :, =>, ∘, A_ldiv_B!, A_ldiv_Bc, A_ldiv_Bt, A_mul_B!, A_mul_Bc, A_mul_Bc!, A_mul_Bt, A_mul_Bt!, A_rdiv_Bc, A_rdiv_Bt, Ac_ldiv_B, Ac_ldiv_B!, Ac_ldiv_Bc, Ac_mul_B, Ac_mul_B!, Ac_mul_Bc, Ac_mul_Bc!, Ac_rdiv_B, Ac_rdiv_Bc, At_ldiv_B, At_ldiv_B!, At_ldiv_Bt, At_mul_B, At_mul_B!, At_mul_Bt, At_mul_Bt!, At_rdiv_B, At_rdiv_Bt, # scalar math @evalpoly, abs, abs2, acos, acosd, acosh, acot, acotd, acoth, acsc, acscd, acsch, angle, asec, asecd, asech, asin, asind, asinh, atan, atan2, atand, atanh, big, binomial, bswap, cbrt, ceil, cis, clamp, cld, cmp, complex, conj, copysign, cos, cosc, cosd, cosh, cospi, cot, cotd, coth, count_ones, count_zeros, csc, cscd, csch, deg2rad, denominator, div, divrem, eps, exp, exp10, exp2, expm1, exponent, factorial, fld, fld1, fldmod, fldmod1, flipsign, float, tryparse, floor, fma, frexp, gamma, gcd, gcdx, hex2num, hypot, imag, inv, invmod, isapprox, iseven, isfinite, isinf, isinteger, isnan, isodd, ispow2, isqrt, isreal, issubnormal, iszero, lcm, ldexp, leading_ones, leading_zeros, lfact, lgamma, log, log10, log1p, log2, maxintfloat, mod, mod1, modf, mod2pi, muladd, nextfloat, nextpow, nextpow2, nextprod, numerator, num2hex, one, oneunit, powermod, prevfloat, prevpow, prevpow2, rad2deg, rationalize, real, realmax, realmin, reim, reinterpret, rem, rem2pi, round, sec, secd, sech, sign, signbit, signed, signif, significand, sin, sinc, sind, sinh, sinpi, sqrt, tan, tand, tanh, trailing_ones, trailing_zeros, trunc, unsafe_trunc, typemax, typemin, unsigned, widemul, zero, √, ∛, ≈, ≉, # specfun beta, lbeta, # arrays broadcast!, broadcast, broadcast_getindex, broadcast_setindex!, cat, checkbounds, checkindex, circcopy!, circshift, circshift!, clamp!, colon, conj!, copy!, cumprod, cumprod!, cumsum, cumsum!, accumulate, accumulate!, cumsum_kbn, eachindex, extrema, fill!, fill, find, findfirst, findlast, findin, findmax, findmin, findmin!, findmax!, findn, findnext, findprev, findnz, first, flipdim, gradient, hcat, hvcat, ind2sub, indexin, indices, indmax, indmin, invperm, ipermute!, isassigned, isperm, issorted, last, linearindices, linspace, logspace, mapslices, max, maximum!, maximum, min, minimum!, minimum, minmax, ndims, nonzeros, countnz, ones, parent, parentindexes, permute, permute!, permutedims, permutedims!, prod!, prod, promote_shape, randcycle, randperm, randsubseq!, randsubseq, range, reducedim, repmat, reshape, reverse!, reverse, rot180, rotl90, rotr90, searchsorted, searchsortedfirst, searchsortedlast, select!, select, shuffle, shuffle!, size, slicedim, sort!, sort, sortcols, selectperm, selectperm!, sortperm, sortperm!, sortrows, squeeze, step, stride, strides, sub2ind, sum!, sum, sum_kbn, to_indices, vcat, vec, view, zeros, # linear algebra bkfact!, bkfact, blkdiag, chol, cholfact!, cholfact, cond, condskeel, cross, ctranspose!, ctranspose, det, diag, diagind, diagm, diff, dot, eig, eigfact!, eigfact, eigmax, eigmin, eigs, eigvals, eigvals!, eigvecs, expm, eye, factorize, givens, hessfact!, hessfact, isdiag, ishermitian, isposdef!, isposdef, issymmetric, istril, istriu, kron, ldltfact, ldltfact!, linreg, logabsdet, logdet, logm, lu, lufact!, lufact, lyap, norm, normalize, normalize!, nullspace, ordschur!, ordschur, peakflops, pinv, qr, qrfact!, qrfact, lq, lqfact!, lqfact, rank, scale!, schur, schurfact!, schurfact, sqrtm, svd, svdfact!, svdfact, svds, svdvals!, svdvals, sylvester, trace, transpose!, transpose, tril!, tril, triu!, triu, vecdot, vecnorm, ⋅, ×, # sparse full, dropzeros, dropzeros!, # bitarrays falses, flipbits!, rol, rol!, ror, ror!, trues, # dequeues append!, insert!, pop!, prepend!, push!, resize!, shift!, unshift!, # collections all!, all, allunique, any!, any, collect, contains, count, delete!, deleteat!, eltype, empty!, endof, filter!, filter, foldl, foldr, foreach, get, get!, getindex, getkey, haskey, in, intersect!, intersect, isempty, issubset, keys, keytype, length, map!, map, mapfoldl, mapfoldr, mapreduce, mapreducedim, merge!, merge, #pop!, #push!, reduce, setdiff!, setdiff, setindex!, similar, sizehint!, splice!, symdiff!, symdiff, union!, union, unique, values, valtype, ∈, ∉, ∋, ∌, ⊆, ⊈, ⊊, ∩, ∪, # strings and text output ascii, base, base64encode, base64decode, Base64EncodePipe, Base64DecodePipe, startswith, bin, bits, bytes2hex, charwidth, chomp, chop, chr2ind, codeunit, dec, digits, digits!, dump, eachmatch, endswith, escape_string, graphemes, hex, hex2bytes, ind2chr, info, is_assigned_char, isalnum, isalpha, isascii, iscntrl, isdigit, isgraph, islower, ismatch, isnumber, isprint, ispunct, isspace, isupper, isvalid, isxdigit, join, lcfirst, logging, lowercase, lpad, lstrip, match, matchall, ndigits, nextind, normalize_string, oct, prevind, print, print_shortest, print_with_color, println, randstring, repeat, replace, repr, reverseind, rpad, rsearch, rsearchindex, rsplit, rstrip, search, searchindex, show, showall, showcompact, showerror, split, sprint, string, strip, strwidth, summary, titlecase, transcode, ucfirst, unescape_string, uppercase, warn, # random numbers AbstractRNG, MersenneTwister, RandomDevice, rand!, rand, randn!, randn, randexp!, randexp, srand, bitrand, randjump, # bigfloat & precision precision, rounding, setprecision, setrounding, get_zero_subnormals, set_zero_subnormals, # statistics cor, cov, mean!, mean, median!, median, middle, quantile!, quantile, std, stdm, var, varm, # signal processing bfft!, bfft, brfft, conv, conv2, dct!, dct, deconv, fft!, fft, fftshift, filt, filt!, idct!, idct, ifft!, ifft, ifftshift, irfft, plan_bfft!, plan_bfft, plan_brfft, plan_dct!, plan_dct, plan_fft!, plan_fft, plan_idct!, plan_idct, plan_ifft!, plan_ifft, plan_irfft, plan_rfft, rfft, xcorr, # iteration done, next, start, enumerate, # re-exported from Iterators zip, # object identity and equality copy, deepcopy, hash, identity, isbits, isequal, isimmutable, isless, ifelse, lexless, lexcmp, object_id, sizeof, # tasks and conditions Condition, current_task, islocked, istaskdone, istaskstarted, lock, notify, ReentrantLock, schedule, task_local_storage, trylock, unlock, yield, yieldto, wait, timedwait, asyncmap, asyncmap!, # channels take!, put!, isready, fetch, # time sleep, tic, time, time_ns, toc, toq, # dates Date, DateTime, DateFormat, @dateformat_str, now, # errors assert, backtrace, catch_backtrace, error, rethrow, retry, systemerror, # stack traces StackTrace, StackFrame, stacktrace, catch_stacktrace, # types convert, fieldoffset, fieldname, fieldnames, isleaftype, oftype, promote, promote_rule, promote_type, subtypes, instances, supertype, typeintersect, typejoin, widen, # syntax esc, expand, gensym, macroexpand, @macroexpand, parse, # help and reflection apropos, current_module, edit, code_typed, code_warntype, code_lowered, code_llvm, code_native, fullname, functionloc, isconst, isinteractive, less, method_exists, methods, methodswith, module_name, module_parent, names, versioninfo, which, whos, workspace, # loading source files __precompile__, evalfile, include, include_string, include_dependency, reload, # RTS internals finalizer, finalize, gc, gc_enable, precompile, # misc atexit, atreplinit, clipboard, exit, ntuple, quit, # IP address stuff @ip_str, IPAddr, IPv4, IPv6, # I/O and events accept, bind, close, connect, countlines, deserialize, eachline, eof, fd, fdio, flush, getaddrinfo, gethostname, getipaddr, getsockname, htol, hton, IOContext, displaysize, ismarked, isopen, isreadonly, listen, listenany, ltoh, mark, nb_available, ntoh, open, pipeline, Pipe, PipeBuffer, poll_fd, poll_file, position, RawFD, read, read!, readavailable, readbytes!, readchomp, readcsv, readdir, readdlm, readline, readlines, readstring, readuntil, redirect_stderr, redirect_stdin, redirect_stdout, recv, recvfrom, reset, seek, seekend, seekstart, send, serialize, skip, skipchars, take!, truncate, unmark, watch_file, write, writecsv, writedlm, TCPSocket, UDPSocket, # multimedia I/O Display, display, displayable, TextDisplay, istextmime, MIME, @MIME_str, reprmime, stringmime, mimewritable, popdisplay, pushdisplay, redisplay, HTML, Text, # shared arrays sdata, indexpids, localindexes, # paths and file names abspath, basename, dirname, expanduser, homedir, isabspath, isdirpath, joinpath, normpath, realpath, relpath, splitdir, splitdrive, splitext, # filesystem operations cd, chmod, chown, cp, ctime, download, filemode, filesize, gperm, isblockdev, ischardev, isdir, isfifo, isfile, islink, ismount, ispath, isreadable, issetgid, issetuid, issocket, issticky, iswritable, lstat, mkdir, mkpath, mktemp, mktempdir, mtime, mv, operm, pwd, readlink, rm, stat, symlink, tempdir, tempname, touch, uperm, walkdir, # external processes ## TODO: whittle down these exports. detach, getpid, ignorestatus, kill, process_exited, process_running, readandwrite, run, setenv, spawn, success, withenv, # C interface cfunction, cglobal, disable_sigint, pointer, pointer_from_objref, unsafe_wrap, unsafe_string, reenable_sigint, unsafe_copy!, unsafe_load, unsafe_pointer_to_objref, unsafe_read, unsafe_store!, unsafe_write, # nullable types isnull, unsafe_get, # Macros # parser internal @__FILE__, @__DIR__, @int128_str, @uint128_str, @big_str, @cmd, # `commands` # notation for certain types @b_str, # byte vector @r_str, # regex @s_str, # regex substitution string @v_str, # version number @raw_str, # raw string with no interpolation/unescaping # documentation @text_str, @html_str, @doc, @doc_str, # output @show, @printf, @sprintf, # profiling @time, @timed, @timev, @elapsed, @allocated, @profile, # reflection @which, @edit, @functionloc, @less, @code_typed, @code_warntype, @code_lowered, @code_llvm, @code_native, # platform-conditional code @static, is_windows, is_linux, is_apple, is_bsd, is_unix, # tasks @schedule, @sync, @async, @task, @threadcall, # metaprogramming utilities @generated, @gensym, @eval, @deprecate, # performance annotations @boundscheck, @inbounds, @fastmath, @simd, @inline, @noinline, @polly, @assert, @__dot__, @enum, @label, @goto, @view, @views, # SparseArrays module re-exports SparseArrays, AbstractSparseArray, AbstractSparseMatrix, AbstractSparseVector, SparseMatrixCSC, SparseVector, issparse, sparse, sparsevec, spdiagm, speye, spones, sprand, sprandn, spzeros, rowvals, nzrange, nnz, # Parallel module re-exports @spawn, @spawnat, @fetch, @fetchfrom, @everywhere, @parallel, addprocs, CachingPool, clear!, ClusterManager, default_worker_pool, init_worker, interrupt, launch, manage, myid, nprocs, nworkers, pmap, procs, remote, remotecall, remotecall_fetch, remotecall_wait, remote_do, rmprocs, workers, WorkerPool, RemoteChannel, Future, WorkerConfig, RemoteException, ProcessExitedException