gsl.randist

D bindings for GSL.

Members

Functions

gsl_ran_bernoulli
uint gsl_ran_bernoulli(const(gsl_rng)* r, double p)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_bernoulli_pdf
double gsl_ran_bernoulli_pdf(uint k, double p)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_beta
double gsl_ran_beta(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_beta_pdf
double gsl_ran_beta_pdf(double x, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_binomial
uint gsl_ran_binomial(const(gsl_rng)* r, double p, uint n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_binomial_knuth
uint gsl_ran_binomial_knuth(const(gsl_rng)* r, double p, uint n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_binomial_pdf
double gsl_ran_binomial_pdf(uint k, double p, uint n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_binomial_tpe
uint gsl_ran_binomial_tpe(const(gsl_rng)* r, double p, uint n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_bivariate_gaussian
void gsl_ran_bivariate_gaussian(const(gsl_rng)* r, double sigma_x, double sigma_y, double rho, double* x, double* y)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_bivariate_gaussian_pdf
double gsl_ran_bivariate_gaussian_pdf(double x, double y, double sigma_x, double sigma_y, double rho)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_cauchy
double gsl_ran_cauchy(const(gsl_rng)* r, double a)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_cauchy_pdf
double gsl_ran_cauchy_pdf(double x, double a)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_chisq
double gsl_ran_chisq(const(gsl_rng)* r, double nu)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_chisq_pdf
double gsl_ran_chisq_pdf(double x, double nu)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_choose
int gsl_ran_choose(const(gsl_rng)* r, void* dest, size_t k, void* src, size_t n, size_t size)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_dir_2d
void gsl_ran_dir_2d(const(gsl_rng)* r, double* x, double* y)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_dir_2d_trig_method
void gsl_ran_dir_2d_trig_method(const(gsl_rng)* r, double* x, double* y)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_dir_3d
void gsl_ran_dir_3d(const(gsl_rng)* r, double* x, double* y, double* z)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_dir_nd
void gsl_ran_dir_nd(const(gsl_rng)* r, size_t n, double* x)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_dirichlet
void gsl_ran_dirichlet(const(gsl_rng)* r, size_t K, const(double)* alpha, double* theta)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_dirichlet_lnpdf
double gsl_ran_dirichlet_lnpdf(size_t K, const(double)* alpha, const(double)* theta)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_dirichlet_pdf
double gsl_ran_dirichlet_pdf(size_t K, const(double)* alpha, const(double)* theta)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_discrete
size_t gsl_ran_discrete(const(gsl_rng)* r, const(gsl_ran_discrete_t)* g)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_discrete_free
void gsl_ran_discrete_free(gsl_ran_discrete_t* g)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_discrete_pdf
double gsl_ran_discrete_pdf(size_t k, const(gsl_ran_discrete_t)* g)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_discrete_preproc
gsl_ran_discrete_t* gsl_ran_discrete_preproc(size_t K, const(double)* P)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_erlang
double gsl_ran_erlang(const(gsl_rng)* r, double a, double n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_erlang_pdf
double gsl_ran_erlang_pdf(double x, double a, double n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_exponential
double gsl_ran_exponential(const(gsl_rng)* r, double mu)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_exponential_pdf
double gsl_ran_exponential_pdf(double x, double mu)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_exppow
double gsl_ran_exppow(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_exppow_pdf
double gsl_ran_exppow_pdf(double x, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_fdist
double gsl_ran_fdist(const(gsl_rng)* r, double nu1, double nu2)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_fdist_pdf
double gsl_ran_fdist_pdf(double x, double nu1, double nu2)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_flat
double gsl_ran_flat(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_flat_pdf
double gsl_ran_flat_pdf(double x, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gamma
double gsl_ran_gamma(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gamma_int
double gsl_ran_gamma_int(const(gsl_rng)* r, uint a)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gamma_knuth
double gsl_ran_gamma_knuth(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gamma_mt
double gsl_ran_gamma_mt(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gamma_pdf
double gsl_ran_gamma_pdf(double x, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gaussian
double gsl_ran_gaussian(const(gsl_rng)* r, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gaussian_pdf
double gsl_ran_gaussian_pdf(double x, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gaussian_ratio_method
double gsl_ran_gaussian_ratio_method(const(gsl_rng)* r, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gaussian_tail
double gsl_ran_gaussian_tail(const(gsl_rng)* r, double a, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gaussian_tail_pdf
double gsl_ran_gaussian_tail_pdf(double x, double a, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gaussian_ziggurat
double gsl_ran_gaussian_ziggurat(const(gsl_rng)* r, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_geometric
uint gsl_ran_geometric(const(gsl_rng)* r, double p)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_geometric_pdf
double gsl_ran_geometric_pdf(uint k, double p)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gumbel1
double gsl_ran_gumbel1(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gumbel1_pdf
double gsl_ran_gumbel1_pdf(double x, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gumbel2
double gsl_ran_gumbel2(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_gumbel2_pdf
double gsl_ran_gumbel2_pdf(double x, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_hypergeometric
uint gsl_ran_hypergeometric(const(gsl_rng)* r, uint n1, uint n2, uint t)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_hypergeometric_pdf
double gsl_ran_hypergeometric_pdf(uint k, uint n1, uint n2, uint t)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_landau
double gsl_ran_landau(const(gsl_rng)* r)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_landau_pdf
double gsl_ran_landau_pdf(double x)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_laplace
double gsl_ran_laplace(const(gsl_rng)* r, double a)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_laplace_pdf
double gsl_ran_laplace_pdf(double x, double a)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_levy
double gsl_ran_levy(const(gsl_rng)* r, double c, double alpha)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_levy_skew
double gsl_ran_levy_skew(const(gsl_rng)* r, double c, double alpha, double beta)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_logarithmic
uint gsl_ran_logarithmic(const(gsl_rng)* r, double p)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_logarithmic_pdf
double gsl_ran_logarithmic_pdf(uint k, double p)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_logistic
double gsl_ran_logistic(const(gsl_rng)* r, double a)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_logistic_pdf
double gsl_ran_logistic_pdf(double x, double a)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_lognormal
double gsl_ran_lognormal(const(gsl_rng)* r, double zeta, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_lognormal_pdf
double gsl_ran_lognormal_pdf(double x, double zeta, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_multinomial
void gsl_ran_multinomial(const(gsl_rng)* r, size_t K, uint N, const(double)* p, uint* n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_multinomial_lnpdf
double gsl_ran_multinomial_lnpdf(size_t K, const(double)* p, const(uint)* n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_multinomial_pdf
double gsl_ran_multinomial_pdf(size_t K, const(double)* p, const(uint)* n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_negative_binomial
uint gsl_ran_negative_binomial(const(gsl_rng)* r, double p, double n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_negative_binomial_pdf
double gsl_ran_negative_binomial_pdf(uint k, double p, double n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_pareto
double gsl_ran_pareto(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_pareto_pdf
double gsl_ran_pareto_pdf(double x, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_pascal
uint gsl_ran_pascal(const(gsl_rng)* r, double p, uint n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_pascal_pdf
double gsl_ran_pascal_pdf(uint k, double p, uint n)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_poisson
uint gsl_ran_poisson(const(gsl_rng)* r, double mu)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_poisson_array
void gsl_ran_poisson_array(const(gsl_rng)* r, size_t n, uint* array, double mu)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_poisson_pdf
double gsl_ran_poisson_pdf(uint k, double mu)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_rayleigh
double gsl_ran_rayleigh(const(gsl_rng)* r, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_rayleigh_pdf
double gsl_ran_rayleigh_pdf(double x, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_rayleigh_tail
double gsl_ran_rayleigh_tail(const(gsl_rng)* r, double a, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_rayleigh_tail_pdf
double gsl_ran_rayleigh_tail_pdf(double x, double a, double sigma)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_sample
void gsl_ran_sample(const(gsl_rng)* r, void* dest, size_t k, void* src, size_t n, size_t size)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_shuffle
void gsl_ran_shuffle(const(gsl_rng)* r, void* base, size_t nmembm, size_t size)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_tdist
double gsl_ran_tdist(const(gsl_rng)* r, double nu)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_tdist_pdf
double gsl_ran_tdist_pdf(double x, double nu)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_ugaussian
double gsl_ran_ugaussian(const(gsl_rng)* r)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_ugaussian_pdf
double gsl_ran_ugaussian_pdf(double x)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_ugaussian_ratio_method
double gsl_ran_ugaussian_ratio_method(const(gsl_rng)* r)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_ugaussian_tail
double gsl_ran_ugaussian_tail(const(gsl_rng)* r, double a)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_ugaussian_tail_pdf
double gsl_ran_ugaussian_tail_pdf(double x, double a)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_weibull
double gsl_ran_weibull(const(gsl_rng)* r, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.
gsl_ran_weibull_pdf
double gsl_ran_weibull_pdf(double x, double a, double b)
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.

Structs

gsl_ran_discrete_t
struct gsl_ran_discrete_t
Undocumented in source but is binding to C. You might be able to learn more by searching the web for its name.

Meta

Authors

Chibisi Chima-Okereke

License

Boost License 1.0