Package actyr. August 5, 2015

Size: px
Start display at page:

Download "Package actyr. August 5, 2015"

Transcription

1 Type Package Package actyr August 5, 2015 Title Replication Package for Abbring, Campbell, Tilly, Yang (2014): Very Simple Markov Perfect Industry Dynamics Version 1.0 Date Author Jan Tilly URL Maintainer Jan Tilly This is the replication package for Abbring, Campbell, Tilly, Yang (2014): Very Simple Markov Perfect Industry Dynamics. It contains an example program, the Monte Carlo simulation, and the empirical illustration. The computationally intensive functions are all implemented in C++. -handling, model specification, and optimization is done in R. In addition to the nested fixed-point estimation (NFXP) algorithm that is presented in the paper, this package also includes an implementation of an MPEC (Mathematical Programming with Equilibrium Constraints) estimation algorithm. For this part only, a Knitro license is required. Knitro can then be used from R via the package knitror. License GPL-2 Imports Rcpp LinkingTo Rcpp, RcppArmadillo Depends gaussquad, tikzdevice, foreach, tictoc Suggests testthat R topics documented: actyr-package computemixingdensity computemodelmeans consolidatephis cov

2 2 actyr-package dpidmu dpidsigma ergodic firms getextractc getextractn getmodeltransitionmatrix likelihood likelihoodgradient mixingdensitygradient mixingprobabilities mpecconstraint mpecconstraintgradient mpeclikelihood mpeclikelihoodgradient mpecmixingdensitygradient N nfxp.covariance.step nfxp.gradient.step nfxp.gradient.step nfxp.gradient.step nfxp.likelihood.step nfxp.likelihood.step nfxp.likelihood.step onestepaheadforecast onestepaheadforecastoneovern population simulate tauchen valuefunction Index 23 actyr-package R / C++ programs for Abbring, Campbell, Tilly Yang (2014): Very Simple Markov Perfect Industry Dynamics This is the replication package for Abbring, Campbell, Tilly, Yang (2014): Very Simple Markov Perfect Industry Dynamics. It contains an example program, the Monte Carlo simulation, and the empirical illustration. The computationally intensive functions are all implemented in C++. -handling, model specification, and optimization is done in R. In addition to the nested fixedpoint estimation (NFXP) algorithm that is presented in the paper, this package also includes an implementation of an MPEC (Mathematical Programming with Equilibrium Constraints) estimation algorithm. For this part only, a Knitro license is required. Knitro can then be used from R via the package knitror.

3 computemixingdensity 3 Introduction This package contains an Rcpp implementation for the paper Very Simple Industry Dynamics. The C++ code is kept as generic as possible. The user only gets to choose the parameter ncheck. For a given ncheck, the C++ code assumes that there is a vector of surplus parameters k of length ncheck, a vector of entry cost parameters phi of length ncheck, and a scalar valued parameters omega. Any model restrictions are processed in R. E.g. in all of our specifications used in the paper, we require that phi(1)=...=phi(5). Similarly, a specification with covariates is simply changing the surplus parameters k. Thus, using the code and running different specifications will only involve changing the R code, not the C++ code. Example demo(example_nfxp) runs a simple example that generates a dataset and then estimates the model parameters using the Nested Fixed Point Algorithm. This code is stored in demo/example_nfxp.r. Replication The Monte Carlo results from the paper can be replicated by running demo(montecarlo). This code is stored in demo/montecarlo.r. The empirical illustration from the paper can be replicated by running demo(empirical). This code is stored in demo/empirical.r. Author(s) Jan Tilly See Also The paper is available at A Matlab sandbox is available at An extensive documentation of the Matlab sandbox is available at computemixingdensity Compute the mixing density This function computes the mixing density and returns it as a cube. computemixingdensity(,, vs) vs is an R list of settings is an R list of of parameters is a matrix with the value functions

4 4 consolidatephis A cube with the mixing density. computemodelmeans Compute the model means for Tforward periods Compute the model means for Tforward periods computemodelmeans(prime,, Tforward, initialc) Prime Tforward initialc structure structure integer vector with the initial distribution for the demand state matrix with means consolidatephis Consolidates the phis Consolidates the phis consolidatephis(, constraintgradientin) is an R list with constraintgradientin is a matrix with the constraint gradient constraint gradient in which the phis are consolidated into one

5 cov 5 cov Covariates for musas in the year 2000 This data set contains covariates for the musas in the year 2000 Format A data frame with 573 rows and 12 variables id CBSA id name CBSA name inc median income in 2000 dummy1 Middle Atlantic Census Region Dummy dummy2 East North Central Census Region Dummy dummy3 West North Central Census Region Dummy dummy4 South Atlantic Census Region Dummy dummy5 East South Central Census Region Dummy dummy6 West South Central Census Region Dummy dummy7 Mountain Census Region Dummy dummy8 Pacific Census Region Dummy dummy9 Low Diversity Dummy Source dpidmu Compute the gradient of the transition probability matrix with respect to mu Compute the gradient of the transition probability matrix with respect to mu dpidmu(pi, loggrid, mu, sigma)

6 6 dpidsigma Pi loggrid is the transition probability matrix is the demand grid mu is the mean of the innovations times 100 sigma is the standard deviation of the innovations times 100 A matrix with the derivative of the transition probability matrix with respect to mu. dpidsigma Compute the gradient of the transition probability matrix with respect to sigma Compute the gradient of the transition probability matrix with respect to sigma dpidsigma(pi, loggrid, mu, sigma) Pi loggrid mu is the transition probability matrix is the demand grid is the mean of the innovations sigma is the standard deviation of the innovations times 100 A matrix with the derivative of the transition probability matrix with respect to sigma.

7 ergodic 7 ergodic Compute the ergodic distribution of a Markov Chain Computes the ergodic distribution of a discrete Markov chain ergodic(transmat) transmat the transition probability matrix of the Markov chain a vector with the ergodic distribution firms Firm count data for musas from 2000 to 2009 Format This data set contains firm counts for Movie theaters for musas from 2000 to 2009 in panel data format A data frame with 573 rows and 12 variables id CBSA id name CBSA name firms2000 firms in 2000 firms2001 firms in 2001 firms2002 firms in 2002 firms2003 firms in 2003 firms2004 firms in 2004 firms2005 firms in 2005 firms2006 firms in 2006 firms2007 firms in 2007 firms2008 firms in 2008 firms2009 firms in 2009

8 8 getextractn Source getextractc Create extractc matrix Create extractc matrix getextractc(, ) structure structure extractc matrix getextractn Create extractn matrix Create extractn matrix getextractn() structure extractn matrix

9 getmodeltransitionmatrix 9 getmodeltransitionmatrix Computes the model s transition matrix Computes the model s implied transition matrix getmodeltransitionmatrix(, ) is an R list with settings is an R list with parameters square matrix with ccheck * (ncheck+1) rows and columns likelihood Compute likelihood contributions This function computes the vector of likelihood contributions for the data set in. The likelihood contributions are computed as follows: Use the function valuefunction to compute the equilibrium value functions and the entry and sure survival probabilities Compute the mixing density Assemble the likelihood contributions for each observations likelihood(,, ) is an R list of settings is an R list of parameters is an R list of the data and includes the matrices N and C A column vector of likelihood contributions for each observation

10 10 mixingdensitygradient likelihoodgradient Compute the gradient of the likelihood function This function computes the gradient of the likelihood function. It also computes the equilibrium and the likelihood function and then returns a list with the likelihood and gradient contributions. likelihoodgradient(,, ) is an R list of settings is an R list of parameters an R list of the data with matrices C and N An R list with a vector of likelihood contributions and a matrix of gradient contributions. mixingdensitygradient Compute the gradient of the mixing density for a variable of interest This function computes the gradient of the mixing density. Note that all parameters (except for omega) enter the mixing density only through the value functions. The derivative of the value function is given as argument to the function. mixingdensitygradient(,, Eq, D_vS, OMEGA_FLAG = FALSE) Eq D_vS OMEGA_FLAG is an R list of settings is an R list of parameters is an R list of equilibrium objects is a matrix of the gradient of the value function with respect to the variable of interest is a flag whether the variable in question is omega or not A cube of the mixing density p^{-1}(a_s, c, n)

11 mixingprobabilities 11 mixingprobabilities Compute mixing probabilities The function computes the mixing probability for a given state (N,C,W). mixingprobabilities(n, C, W, vs) N C W vs is an integer with the number of firms post-entry is an integer with the index of the demand grid is the a scalar with the current realization of the cost shock is the post-survival value function a scalar with the mixing probability mpecconstraint Compute MPEC constraint This function computes the equilibrium constraint for a given value function guess vs. mpecconstraint(,, vs) vs is an R list of settings is an R list of parameters is a matrix with the current guess of the value function A column vector of length equal to length(vs) with the distance between vs and the result from evaluating the Bellman operator at vs

12 12 mpeclikelihood mpecconstraintgradient Compute the gradient of the equilibrium constraint (MPEC) This function computes the gradient of the equilibrium constraint with respect to all structural parameters and the value functions. It returns the Jacobian. mpecconstraintgradient(,,, vs, CONSOLIDATE_PHIS) is an R list of settings is an R list of parameters an R list of the data with matrices C and N vs is a matrix with the current guess of the value function CONSOLIDATE_PHIS is an indicator whether or not the phis need to be consolidated A matrix with the constraint Jacobian. mpeclikelihood Compute MPEC likelihood contributions This function computes the vector of likelihood contributions for the data set in. The likelihood contributions are computed as follows: The function uses the value function guess vs to construct entry and sure survival probabilities Compute the mixing density Assemble the likelihood contributions for each observations mpeclikelihood(,,, vs)

13 mpeclikelihoodgradient 13 vs is an R list of settings is an R list of parameters is an R list of the data and includes the matrices N and C is a matrix with the current guess of the value function A column vector of likelihood contributions for each observation mpeclikelihoodgradient Compute the gradient of the likelihood function (MPEC) This function computes the gradient of the likelihood function. with respect to all the structural parameters and the value functions. mpeclikelihoodgradient(,,, vs) vs is an R list of settings is an R list of parameters an R list of the data with matrices C and N is a matrix with the current guess of the value function A vector with the gradient of the likelihood function

14 14 mpecmixingdensitygradient mpecmixingdensitygradient Compute the gradient of the mixing density (MPEC) This function computes the gradient of the mixing density with respect to all model parameters and with respect to the value functions. Note that omega is the only structural parameter that shows up in the mixing density directly. mpecmixingdensitygradient(,, Eq, D_vS, OMEGA_FLAG = FALSE) Eq D_vS OMEGA_FLAG is an R list of settings is an R list of parameters is an R list of equilibrium objects is a matrix of the gradient of the value function with respect to the variable of interest is a flag whether the variable in question is omega or not Details Note that with MPEC, we only need to compute the gradient of the mixing density for two scenarios (all other gradients are zero): We need the derivative of the mixing density with respect to omega (in which case D_vS is zero) We need the derivative of the mixing density with respect to vs(n,c), in which case D_vS(n,c) is equal to 1 for this particular (n,c) and zero elsewhere. A cube of the mixing density p^{-1}(a_s, c, n)

15 N30 15 N30 Compute the model means at time 30 as a function of demand at time zero Compute the model means at time 30 as a function of demand at time zero N30(,.factual, extractn).factual extractn structure structure matrix vector with means nfxp.covariance.step3 Third Step Variance-Covariance Matrix This function computes the variance-covariance matrix that corresponds to the third-step likelihood. The function uses the outer-product-of-the-gradient estimator of the hessian. nfxp.covariance.step3(x,,, ) x is a vector of parameters is an R list that contains a matrix C with indices of the demand state and a matrix N with number of active firms is an R list with settings is an R list with parameters Returns a vector with likelihood contributions

16 16 nfxp.gradient.step2 nfxp.gradient.step1 First Step Gradient Function This function computes the gradient used in the first step of the estimation procedure. nfxp.gradient.step1(mu_sigma,,, Pi = NULL) mu_sigma Pi is a vector whose elements are mu and sigma is an R list that contains a matrix C with indices of the demand state is an R list with program, most notably ccheck is the transition probabillity matrix; if Pi is not provided the transition probability matrix is computed based on mu_sigma times length(mygrid). Returns the vector valued gradient of the negative log-likelihood nfxp.gradient.step2 Second Step Gradient Function This function computes the gradient of the second step likelihood function nfxp.gradient.step2(x,,, ) x is a vector of parameters is an R list that contains a matrix C with indices of the demand state and a matrix N with number of active firms is an R list with settings is an R list with parameters Returns a vector of gradients

17 nfxp.gradient.step3 17 nfxp.gradient.step3 Second Step Gradient Function This function computes the gradient of the second step likelihood function nfxp.gradient.step3(x,,,, Pi = NULL) x Pi is a vector of parameters is an R list that contains a matrix C with indices of the demand state and a matrix N with number of active firms is an R list with settings is an R list with parameters is the transition probabillity matrix; if Pi is not provided the transition probability matrix is computed based on x times length(mygrid). Returns a vector of gradients nfxp.likelihood.step1 First Step Likelihood Function This function computes the likelihood used in the first step of the estimation procedure. nfxp.likelihood.step1(mu_sigma,,, Pi = NULL) mu_sigma Pi is a vector whose elements are mu and sigma is an R list that contains a matrix C with indices of the demand state is an R list with program, most notably ccheck is the transition probabillity matrix; if Pi is not provided the transition probability matrix is computed based on x times length(mygrid).

18 18 nfxp.likelihood.step3 Returns the scalar valued negative log-likelihood nfxp.likelihood.step2 Second Step Likelihood Function This function computes the second step likelihood function nfxp.likelihood.step2(x,,, ) x is a vector of parameters is an R list that contains a matrix C with indices of the demand state and a matrix N with number of active firms is an R list with settings is an R list with parameters Returns a vector with likelihood contributions nfxp.likelihood.step3 Third Step Likelihood Function This function computes the third step likelihood function nfxp.likelihood.step3(x,,,, Pi = NULL) x Pi is a vector of parameters is an R list that contains a matrix C with indices of the demand state and a matrix N with number of active firms is an R list with settings is an R list with parameters is the transition probabillity matrix; if Pi is not provided the transition probability matrix is computed based on x times length(mygrid).

19 onestepaheadforecast 19 Returns a vector with likelihood contributions onestepaheadforecast One-step-ahead forecast This function computes the one-step-ahead forecasts for the general model onestepaheadforecast(,, Row) Row is an R list with settings is an R list with parameters is a list containt the row-vectors C and N with data on one particular market Returns a vector with one-step-ahead forecasts onestepaheadforecastoneovern One-step-ahead forecast of 1/n This function computes the one-step-ahead forecasts for the general model for 1/n onestepaheadforecastoneovern(,, Row) Row is an R list with settings is an R list with parameters is a list containt the row-vectors C and N with data on one particular market Returns a vector with one-step-ahead forecasts

20 20 simulate population Population data for musas from 2000 to 2009 This data set contains population data for musas from 2000 to 2009 in panel data format Format A data frame with 573 rows and 12 variables id CBSA id name CBSA name pop2000 population in 2000 pop2001 population in 2001 pop2002 population in 2002 pop2003 population in 2003 pop2004 population in 2004 pop2005 population in 2005 pop2006 population in 2006 pop2007 population in 2007 pop2008 population in 2008 pop2009 population in 2009 Source simulate Generation This function generates a data set and returns a list with matrices N and C simulate(,, rcheck, tcheck, tburn = 25, initc = NULL, initn = NULL)

21 tauchen 21 rcheck tcheck tburn initc initn is an R list of settings is an R list of of params is an integer with the number of markets for which to generate data is an integer with the number of time periods for which to generate data burn in period initial C initial N an R list with the matrices N and C tauchen Tauchen Discretization of an AR(1) Tauchen computes the transition probability matrix for a discretized AR(1) with normally distributed innovations tauchen(mygrid, mu, sigma) mygrid mu sigma A vector with the equidistant support of the stochastic process The mean of the underlying normal distribution The standard deviation of the underlying normal distribution a square transition probability matrix with dimension length(mygrid) times length(mygrid). Examples tauchen( c(1,2,3), 0, 100)

22 22 valuefunction valuefunction Compute equilibrium value functions This function computes the equilibrium value functions and the probabilities of entry and certain survival. functions are computed via backward recursion. For this function to work, the following must have been set: ncheck The maximum number of firms with non-zero flow profits in some state of the world. loggrid The log of the grid tolinner The convergence tolerance for the inner loop maxiter The maximum number of iterations for the inner loop The following elements in must have been set k A vector of length ncheck that determines the flow surplus phi A vector of length ncheck that governs the entry costs omega A scalar that governs the variance of the cost shocks rho The discount factor Pi A transition probability matrix for the demand grid, which is computed via tauchen valuefunction(, ) is an R list of settings is an R list of of parameters List with value functions, entry probabilities and certain survival probabilities.

23 Index actyr-package, 2 computemixingdensity, 3 computemodelmeans, 4 consolidatephis, 4 cov, 5 simulate, 20 tauchen, 21 valuefunction, 22 dpidmu, 5 dpidsigma, 6 ergodic, 7 firms, 7 getextractc, 8 getextractn, 8 getmodeltransitionmatrix, 9 likelihood, 9 likelihoodgradient, 10 mixingdensitygradient, 10 mixingprobabilities, 11 mpecconstraint, 11 mpecconstraintgradient, 12 mpeclikelihood, 12 mpeclikelihoodgradient, 13 mpecmixingdensitygradient, 14 N30, 15 nfxp.covariance.step3, 15 nfxp.gradient.step1, 16 nfxp.gradient.step2, 16 nfxp.gradient.step3, 17 nfxp.likelihood.step1, 17 nfxp.likelihood.step2, 18 nfxp.likelihood.step3, 18 onestepaheadforecast, 19 onestepaheadforecastoneovern, 19 population, 20 23

Package bayesdp. July 10, 2018

Package bayesdp. July 10, 2018 Type Package Package bayesdp July 10, 2018 Title Tools for the Bayesian Discount Prior Function Version 1.3.2 Date 2018-07-10 Depends R (>= 3.2.3), ggplot2, survival, methods Functions for data augmentation

More information

Package PUlasso. April 7, 2018

Package PUlasso. April 7, 2018 Type Package Package PUlasso April 7, 2018 Title High-Dimensional Variable Selection with Presence-Only Data Version 3.1 Date 2018-4-4 Efficient algorithm for solving PU (Positive and Unlabelled) problem

More information

Package ECctmc. May 1, 2018

Package ECctmc. May 1, 2018 Type Package Package ECctmc May 1, 2018 Title Simulation from Endpoint-Conditioned Continuous Time Markov Chains Version 0.2.5 Date 2018-04-30 URL https://github.com/fintzij/ecctmc BugReports https://github.com/fintzij/ecctmc/issues

More information

Expectation-Maximization Methods in Population Analysis. Robert J. Bauer, Ph.D. ICON plc.

Expectation-Maximization Methods in Population Analysis. Robert J. Bauer, Ph.D. ICON plc. Expectation-Maximization Methods in Population Analysis Robert J. Bauer, Ph.D. ICON plc. 1 Objective The objective of this tutorial is to briefly describe the statistical basis of Expectation-Maximization

More information

Package acebayes. R topics documented: November 21, Type Package

Package acebayes. R topics documented: November 21, Type Package Type Package Package acebayes November 21, 2018 Title Optimal Bayesian Experimental Design using the ACE Algorithm Version 1.5.2 Date 2018-11-21 Author Antony M. Overstall, David C. Woods & Maria Adamou

More information

Institute for Statics und Dynamics of Structures Fuzzy Time Series

Institute for Statics und Dynamics of Structures Fuzzy Time Series Institute for Statics und Dynamics of Structures Fuzzy Time Series Bernd Möller 1 Description of fuzzy time series 2 3 4 5 Conclusions Folie 2 von slide422 1 Description of fuzzy time series 2 3 4 5 Conclusions

More information

Package mixsqp. November 14, 2018

Package mixsqp. November 14, 2018 Encoding UTF-8 Type Package Version 0.1-79 Date 2018-11-05 Package mixsqp November 14, 2018 Title Sequential Quadratic Programming for Fast Maximum-Likelihood Estimation of Mixture Proportions URL https://github.com/stephenslab/mixsqp

More information

Package mfbvar. December 28, Type Package Title Mixed-Frequency Bayesian VAR Models Version Date

Package mfbvar. December 28, Type Package Title Mixed-Frequency Bayesian VAR Models Version Date Type Package Title Mied-Frequency Bayesian VAR Models Version 0.4.0 Date 2018-12-17 Package mfbvar December 28, 2018 Estimation of mied-frequency Bayesian vector autoregressive (VAR) models with Minnesota

More information

Package robustreg. R topics documented: April 27, Version Date Title Robust Regression Functions

Package robustreg. R topics documented: April 27, Version Date Title Robust Regression Functions Version 0.1-10 Date 2017-04-25 Title Robust Regression Functions Package robustreg April 27, 2017 Author Ian M. Johnson Maintainer Ian M. Johnson Depends

More information

Package GADAG. April 11, 2017

Package GADAG. April 11, 2017 Type Package Package GADAG April 11, 2017 Title A Genetic Algorithm for Learning Directed Acyclic Graphs Version 0.99.0 Date 2017-04-07 Author Magali Champion, Victor Picheny and Matthieu Vignes Maintainer

More information

THE RECURSIVE LOGIT MODEL TUTORIAL

THE RECURSIVE LOGIT MODEL TUTORIAL THE RECURSIVE LOGIT MODEL TUTORIAL CIRRELT SEMINAR August 2017 MAELLE ZIMMERMANN, TIEN MAI, EMMA FREJINGER CIRRELT and Université de Montréal, Canada Ecole Polytechnique de Montréal, Canada TUTORIAL GOALS

More information

The gbev Package. August 19, 2006

The gbev Package. August 19, 2006 The gbev Package August 19, 2006 Version 0.1 Date 2006-08-10 Title Gradient Boosted Regression Trees with Errors-in-Variables Author Joe Sexton Maintainer Joe Sexton

More information

Package bife. May 7, 2017

Package bife. May 7, 2017 Type Package Title Binary Choice Models with Fixed Effects Version 0.4 Date 2017-05-06 Package May 7, 2017 Estimates fixed effects binary choice models (logit and probit) with potentially many individual

More information

Introduction to Programming in C Department of Computer Science and Engineering. Lecture No. #16 Loops: Matrix Using Nested for Loop

Introduction to Programming in C Department of Computer Science and Engineering. Lecture No. #16 Loops: Matrix Using Nested for Loop Introduction to Programming in C Department of Computer Science and Engineering Lecture No. #16 Loops: Matrix Using Nested for Loop In this section, we will use the, for loop to code of the matrix problem.

More information

STATISTICS (STAT) Statistics (STAT) 1

STATISTICS (STAT) Statistics (STAT) 1 Statistics (STAT) 1 STATISTICS (STAT) STAT 2013 Elementary Statistics (A) Prerequisites: MATH 1483 or MATH 1513, each with a grade of "C" or better; or an acceptable placement score (see placement.okstate.edu).

More information

Package alphastable. June 15, 2018

Package alphastable. June 15, 2018 Title Inference for Stable Distribution Version 0.1.0 Package stable June 15, 2018 Author Mahdi Teimouri, Adel Mohammadpour, Saralees Nadarajah Maintainer Mahdi Teimouri Developed

More information

Package gibbs.met documentation

Package gibbs.met documentation Version 1.1-2 Package gibbs.met documentation Title Naive Gibbs Sampling with Metropolis Steps Author Longhai Li of March 26, 2008 Maintainer Longhai Li

More information

The exactloglintest Package

The exactloglintest Package The exactloglintest Package November 2, 2006 Version 1.3.6 Title Monte Carlo Exact Tests for Log-linear models Author Brian Caffo Maintainer Brian Caffo Depends R

More information

Package ordinalclust

Package ordinalclust Type Package Package ordinalclust August 6, 2018 Title Ordinal Data Clustering, Co-Clustering and Classification Version 1.3.1 Date 2018-08-06 Author Margot Selosse, Julien Jacques, Christophe Biernacki

More information

The exactloglintest Package

The exactloglintest Package The exactloglintest Package July 27, 2006 Version 1.3.3 Title Monte Carlo Exact Tests for Log-linear models Author Brian Caffo Maintainer Brian Caffo Depends R (>=

More information

Package scarabee. August 22, 2014

Package scarabee. August 22, 2014 Package scarabee August 22, 2014 Type Package Title Optimization Toolkit for Pharmacokinetic-Pharmacodynamic Models Version 1.1-3 Date 2014-02-09 Author Sebastien Bihorel Maintainer Sebastien Bihorel

More information

Package marqlevalg. February 20, 2015

Package marqlevalg. February 20, 2015 Type Package Title An algorithm for least-squares curve fitting Version 1.1 Date 2013-03-01 Package marqlevalg February 20, 2015 Author D. Commenges , M. Prague

More information

CS 543: Final Project Report Texture Classification using 2-D Noncausal HMMs

CS 543: Final Project Report Texture Classification using 2-D Noncausal HMMs CS 543: Final Project Report Texture Classification using 2-D Noncausal HMMs Felix Wang fywang2 John Wieting wieting2 Introduction We implement a texture classification algorithm using 2-D Noncausal Hidden

More information

Package strat. November 23, 2016

Package strat. November 23, 2016 Type Package Package strat November 23, 2016 Title An Implementation of the Stratification Index Version 0.1 An implementation of the stratification index proposed by Zhou (2012) .

More information

Package MTLR. March 9, 2019

Package MTLR. March 9, 2019 Type Package Package MTLR March 9, 2019 Title Survival Prediction with Multi-Task Logistic Regression Version 0.2.0 Author Humza Haider Maintainer Humza Haider URL https://github.com/haiderstats/mtlr

More information

Package stochprofml. February 20, 2015

Package stochprofml. February 20, 2015 Type Package Package stochprofml February 20, 2015 Title Stochastic Profiling using Maximum Likelihood Estimation Version 1.2 Date 2014-10-17 Author Maintainer

More information

Package multdyn. R topics documented: August 24, Version 1.6 Date Title Multiregression Dynamic Models

Package multdyn. R topics documented: August 24, Version 1.6 Date Title Multiregression Dynamic Models Version 1.6 Date 2017-08-24 Title Multiregression Dynamic Models Package multdyn August 24, 2017 Author Simon Schwab , Ruth Harbord , Lilia Costa ,

More information

Package HKprocess. R topics documented: September 6, Type Package. Title Hurst-Kolmogorov process. Version

Package HKprocess. R topics documented: September 6, Type Package. Title Hurst-Kolmogorov process. Version Package HKprocess September 6, 2014 Type Package Title Hurst-Kolmogorov process Version 0.0-1 Date 2014-09-06 Author Maintainer Imports MCMCpack (>= 1.3-3), gtools(>= 3.4.1) Depends

More information

Package ALKr. August 29, 2016

Package ALKr. August 29, 2016 Type Package Package ALKr August 29, 2016 Title Generate Age-Length Keys for fish populations A collection of functions that implement several algorithms for generating age-length keys for fish populations

More information

Package GUTS. R topics documented: October 10, Type Package

Package GUTS. R topics documented: October 10, Type Package Type Package Package GUTS October 10, 2017 Title Fast Calculation of the Likelihood of a Stochastic Survival Model Version 1.0.4 Date 2017-10-09 Author Carlo Albert and Sören Vogel

More information

Package BAMBI. R topics documented: August 28, 2017

Package BAMBI. R topics documented: August 28, 2017 Type Package Title Bivariate Angular Mixture Models Version 1.1.1 Date 2017-08-23 Author Saptarshi Chakraborty, Samuel W.K. Wong Package BAMBI August 28, 2017 Maintainer Saptarshi Chakraborty

More information

Package libstabler. June 1, 2017

Package libstabler. June 1, 2017 Version 1.0 Date 2017-05-25 Package libstabler June 1, 2017 Title Fast and Accurate Evaluation, Random Number Generation and Parameter Estimation of Skew Stable Distributions Tools for fast and accurate

More information

7 Control Structures, Logical Statements

7 Control Structures, Logical Statements 7 Control Structures, Logical Statements 7.1 Logical Statements 1. Logical (true or false) statements comparing scalars or matrices can be evaluated in MATLAB. Two matrices of the same size may be compared,

More information

Package dirmcmc. R topics documented: February 27, 2017

Package dirmcmc. R topics documented: February 27, 2017 Type Package Title Directional Metropolis Hastings Algorithm Version 1.3.3 Date 2017-02-17 Author Abhirup Mallik Package dirmcmc February 27, 2017 Maintainer Abhirup Mallik

More information

Package PedCNV. February 19, 2015

Package PedCNV. February 19, 2015 Type Package Package PedCNV February 19, 2015 Title An implementation for association analysis with CNV data. Version 0.1 Date 2013-08-03 Author, Sungho Won and Weicheng Zhu Maintainer

More information

The MKLE Package. July 24, Kdensity... 1 Kernels... 3 MKLE-package... 3 checkparms... 4 Klik... 5 MKLE... 6 mklewarp... 7 state... 8.

The MKLE Package. July 24, Kdensity... 1 Kernels... 3 MKLE-package... 3 checkparms... 4 Klik... 5 MKLE... 6 mklewarp... 7 state... 8. The MKLE Package July 24, 2006 Type Package Title Maximum kernel likelihood estimation Version 0.02 Date 2006-07-12 Author Maintainer Package to compute the maximum kernel likelihood

More information

Package RaPKod. February 5, 2018

Package RaPKod. February 5, 2018 Package RaPKod February 5, 2018 Type Package Title Random Projection Kernel Outlier Detector Version 0.9 Date 2018-01-30 Author Jeremie Kellner Maintainer Jeremie Kellner

More information

Package batchmeans. R topics documented: July 4, Version Date

Package batchmeans. R topics documented: July 4, Version Date Package batchmeans July 4, 2016 Version 1.0-3 Date 2016-07-03 Title Consistent Batch Means Estimation of Monte Carlo Standard Errors Author Murali Haran and John Hughes

More information

Package rmi. R topics documented: August 2, Title Mutual Information Estimators Version Author Isaac Michaud [cre, aut]

Package rmi. R topics documented: August 2, Title Mutual Information Estimators Version Author Isaac Michaud [cre, aut] Title Mutual Information Estimators Version 0.1.1 Author Isaac Michaud [cre, aut] Pacage rmi August 2, 2018 Maintainer Isaac Michaud Provides mutual information estimators based on

More information

Package enrich. September 3, 2013

Package enrich. September 3, 2013 Package enrich September 3, 2013 Type Package Title An R package for the analysis of multiple ChIP-seq data Version 2.0 Date 2013-09-01 Author Yanchun Bao , Veronica Vinciotti

More information

Package gibbs.met. February 19, 2015

Package gibbs.met. February 19, 2015 Version 1.1-3 Title Naive Gibbs Sampling with Metropolis Steps Author Longhai Li Package gibbs.met February 19, 2015 Maintainer Longhai Li Depends R (>=

More information

MODFLOW Stochastic Modeling, PEST Null Space Monte Carlo I. Use PEST to create multiple calibrated MODFLOW simulations

MODFLOW Stochastic Modeling, PEST Null Space Monte Carlo I. Use PEST to create multiple calibrated MODFLOW simulations v. 10.1 GMS 10.1 Tutorial MODFLOW Stochastic Modeling, PEST Null Space Monte Carlo I Use PEST to create multiple calibrated MODFLOW simulations Objectives The PEST Null Space Monte Carlo modeling option

More information

High Performance Computing: Tools and Applications

High Performance Computing: Tools and Applications High Performance Computing: Tools and Applications Edmond Chow School of Computational Science and Engineering Georgia Institute of Technology Lecture 15 Numerically solve a 2D boundary value problem Example:

More information

Package kamila. August 29, 2016

Package kamila. August 29, 2016 Type Package Version 0.1.1.1 Date 2016-08-18 Author Alexander Foss [aut, cre], Marianthi Markatou [aut] Package kamila August 29, 2016 Maintainer Alexander Foss Title Methods

More information

Optimization. Using Analytic Solver Platform REVIEW BASED ON MANAGEMENT SCIENCE

Optimization. Using Analytic Solver Platform REVIEW BASED ON MANAGEMENT SCIENCE Optimization Using Analytic Solver Platform REVIEW BASED ON MANAGEMENT SCIENCE What We ll Cover Today Introduction Session ΙΙΙ beta training program goals Automating Optimization in Excel Defining Optimization

More information

Numerical Methods for PDEs : Video 11: 1D FiniteFebruary Difference 15, Mappings Theory / 15

Numerical Methods for PDEs : Video 11: 1D FiniteFebruary Difference 15, Mappings Theory / 15 22.520 Numerical Methods for PDEs : Video 11: 1D Finite Difference Mappings Theory and Matlab February 15, 2015 22.520 Numerical Methods for PDEs : Video 11: 1D FiniteFebruary Difference 15, Mappings 2015

More information

Using the DATAMINE Program

Using the DATAMINE Program 6 Using the DATAMINE Program 304 Using the DATAMINE Program This chapter serves as a user s manual for the DATAMINE program, which demonstrates the algorithms presented in this book. Each menu selection

More information

Package treedater. R topics documented: May 4, Type Package

Package treedater. R topics documented: May 4, Type Package Type Package Package treedater May 4, 2018 Title Fast Molecular Clock Dating of Phylogenetic Trees with Rate Variation Version 0.2.0 Date 2018-04-23 Author Erik Volz [aut, cre] Maintainer Erik Volz

More information

The dblcens Package. August 7, Title Compute the NPMLE of distribution from doubly censored data. d d011ch... 4.

The dblcens Package. August 7, Title Compute the NPMLE of distribution from doubly censored data. d d011ch... 4. The dblcens Package August 7, 2005 Title Compute the NPMLE of distribution from doubly censored data Version 1.1.3 Author Mai Zhou, Li Lee, Kun Chen. Description Use EM algorithm to compute the NPMLE of

More information

Logistic growth model with bssm Jouni Helske 21 November 2017

Logistic growth model with bssm Jouni Helske 21 November 2017 Logistic growth model with bssm Jouni Helske 21 November 2017 Logistic growth model This vignette shows how to model general non-linear state space models with bssm. The general non-linear Gaussian model

More information

Package frequencyconnectedness

Package frequencyconnectedness Type Package Package frequencyconnectedness September 24, 2018 Title Spectral Decomposition of Connectedness Measures Version 0.2.1 Date 2018-09-24 Accompanies a paper (Barunik, Krehlik (2018) )

More information

Package milr. June 8, 2017

Package milr. June 8, 2017 Type Package Package milr June 8, 2017 Title Multiple-Instance Logistic Regression with LASSO Penalty Version 0.3.0 Date 2017-06-05 The multiple instance data set consists of many independent subjects

More information

Overview. EECS 124, UC Berkeley, Spring 2008 Lecture 23: Localization and Mapping. Statistical Models

Overview. EECS 124, UC Berkeley, Spring 2008 Lecture 23: Localization and Mapping. Statistical Models Introduction ti to Embedded dsystems EECS 124, UC Berkeley, Spring 2008 Lecture 23: Localization and Mapping Gabe Hoffmann Ph.D. Candidate, Aero/Astro Engineering Stanford University Statistical Models

More information

Package geogrid. August 19, 2018

Package geogrid. August 19, 2018 Package geogrid August 19, 2018 Title Turn Geospatial Polygons into Regular or Hexagonal Grids Version 0.1.0.1 Turn irregular polygons (such as geographical regions) into regular or hexagonal grids. This

More information

Package StVAR. February 11, 2017

Package StVAR. February 11, 2017 Type Package Title Student's t Vector Autoregression (StVAR) Version 1.1 Date 2017-02-10 Author Niraj Poudyal Maintainer Niraj Poudyal Package StVAR February 11, 2017 Description Estimation

More information

GAMES Webinar: Rendering Tutorial 2. Monte Carlo Methods. Shuang Zhao

GAMES Webinar: Rendering Tutorial 2. Monte Carlo Methods. Shuang Zhao GAMES Webinar: Rendering Tutorial 2 Monte Carlo Methods Shuang Zhao Assistant Professor Computer Science Department University of California, Irvine GAMES Webinar Shuang Zhao 1 Outline 1. Monte Carlo integration

More information

Package sparsehessianfd

Package sparsehessianfd Type Package Package sparsehessianfd Title Numerical Estimation of Sparse Hessians Version 0.3.3.3 Date 2018-03-26 Maintainer Michael Braun March 27, 2018 URL http://www.smu.edu/cox/departments/facultydirectory/braunmichael

More information

An introduction into numerical optimization with KNITRO

An introduction into numerical optimization with KNITRO An introduction into numerical optimization with KNITRO Pawel Doligalski and Dominik Thaler 15 September 2014 KNITRO fval fcount time fmincon -103.6194 2197 1.578750 knitro a'la fmincon -103.1450 144 0.094221

More information

Package mcemglm. November 29, 2015

Package mcemglm. November 29, 2015 Type Package Package mcemglm November 29, 2015 Title Maximum Likelihood Estimation for Generalized Linear Mixed Models Version 1.1 Date 2015-11-28 Author Felipe Acosta Archila Maintainer Maximum likelihood

More information

Package sgmcmc. September 26, Type Package

Package sgmcmc. September 26, Type Package Type Package Package sgmcmc September 26, 2017 Title Stochastic Gradient Markov Chain Monte Carlo Version 0.2.0 Provides functions that performs popular stochastic gradient Markov chain Monte Carlo (SGMCMC)

More information

Our Strategy for Learning Fortran 90

Our Strategy for Learning Fortran 90 Our Strategy for Learning Fortran 90 We want to consider some computational problems which build in complexity. evaluating an integral solving nonlinear equations vector/matrix operations fitting data

More information

A User Manual for the Multivariate MLE Tool. Before running the main multivariate program saved in the SAS file Part2-Main.sas,

A User Manual for the Multivariate MLE Tool. Before running the main multivariate program saved in the SAS file Part2-Main.sas, A User Manual for the Multivariate MLE Tool Before running the main multivariate program saved in the SAS file Part-Main.sas, the user must first compile the macros defined in the SAS file Part-Macros.sas

More information

Package TPD. June 14, 2018

Package TPD. June 14, 2018 Type Package Package TPD June 14, 2018 Title Methods for Measuring Functional Diversity Based on Trait Probability Density Version 1.0.0 Date 2018-06-13 Author Carlos P. Carmona

More information

Package gppm. July 5, 2018

Package gppm. July 5, 2018 Version 0.2.0 Title Gaussian Process Panel Modeling Package gppm July 5, 2018 Provides an implementation of Gaussian process panel modeling (GPPM). GPPM is described in Karch (2016; )

More information

Package atmcmc. February 19, 2015

Package atmcmc. February 19, 2015 Type Package Package atmcmc February 19, 2015 Title Automatically Tuned Markov Chain Monte Carlo Version 1.0 Date 2014-09-16 Author Jinyoung Yang Maintainer Jinyoung Yang

More information

REINFORCEMENT LEARNING: MDP APPLIED TO AUTONOMOUS NAVIGATION

REINFORCEMENT LEARNING: MDP APPLIED TO AUTONOMOUS NAVIGATION REINFORCEMENT LEARNING: MDP APPLIED TO AUTONOMOUS NAVIGATION ABSTRACT Mark A. Mueller Georgia Institute of Technology, Computer Science, Atlanta, GA USA The problem of autonomous vehicle navigation between

More information

Integration. Volume Estimation

Integration. Volume Estimation Monte Carlo Integration Lab Objective: Many important integrals cannot be evaluated symbolically because the integrand has no antiderivative. Traditional numerical integration techniques like Newton-Cotes

More information

Package SSLASSO. August 28, 2018

Package SSLASSO. August 28, 2018 Package SSLASSO August 28, 2018 Version 1.2-1 Date 2018-08-28 Title The Spike-and-Slab LASSO Author Veronika Rockova [aut,cre], Gemma Moran [aut] Maintainer Gemma Moran Description

More information

Package mcmcse. February 15, 2013

Package mcmcse. February 15, 2013 Package mcmcse February 15, 2013 Version 1.0-1 Date 2012 Title Monte Carlo Standard Errors for MCMC Author James M. Flegal and John Hughes Maintainer James M. Flegal

More information

Package nsprcomp. August 29, 2016

Package nsprcomp. August 29, 2016 Version 0.5 Date 2014-02-03 Title Non-Negative and Sparse PCA Package nsprcomp August 29, 2016 Description This package implements two methods for performing a constrained principal component analysis

More information

Package BPHO documentation

Package BPHO documentation Package BPHO documentation of February 22, 2008 Version 1.2-3 Title Bayesian Prediction with High-order Interactions Author Longhai Li Maintainer Longhai Li

More information

Supplementary Material sppmix: Poisson point process modeling using normal mixture models

Supplementary Material sppmix: Poisson point process modeling using normal mixture models Supplementary Material sppmix: Poisson point process modeling using normal mixture models Athanasios C. Micheas and Jiaxun Chen Department of Statistics University of Missouri April 19, 2018 1 The sppmix

More information

Package mvprobit. November 2, 2015

Package mvprobit. November 2, 2015 Version 0.1-8 Date 2015-11-02 Title Multivariate Probit Models Package mvprobit November 2, 2015 Author Arne Henningsen Maintainer Arne Henningsen

More information

Package SAENET. June 4, 2015

Package SAENET. June 4, 2015 Type Package Package SAENET June 4, 2015 Title A Stacked Autoencoder Implementation with Interface to 'neuralnet' Version 1.1 Date 2015-06-04 An implementation of a stacked sparse autoencoder for dimension

More information

Package HMMCont. February 19, 2015

Package HMMCont. February 19, 2015 Type Package Package HMMCont February 19, 2015 Title Hidden Markov Model for Continuous Observations Processes Version 1.0 Date 2014-02-11 Author Maintainer The package includes

More information

Package MonteCarlo. April 23, 2017

Package MonteCarlo. April 23, 2017 Type Package Package MonteCarlo April 23, 2017 Title Automatic Parallelized Monte Carlo Simulations Version 1.0.2 Date 2017-04-23 Author Christian Hendrik Leschinski Maintainer Christian Hendrik Leschinski

More information

Tracking Algorithms. Lecture16: Visual Tracking I. Probabilistic Tracking. Joint Probability and Graphical Model. Deterministic methods

Tracking Algorithms. Lecture16: Visual Tracking I. Probabilistic Tracking. Joint Probability and Graphical Model. Deterministic methods Tracking Algorithms CSED441:Introduction to Computer Vision (2017F) Lecture16: Visual Tracking I Bohyung Han CSE, POSTECH bhhan@postech.ac.kr Deterministic methods Given input video and current state,

More information

The Amelia Package. March 25, 2007

The Amelia Package. March 25, 2007 The Amelia Package March 25, 2007 Version 1.1-23 Date 2007-03-24 Title Amelia II: A Program for Missing Data Author James Honaker , Gary King , Matthew Blackwell

More information

Package ccapp. March 7, 2016

Package ccapp. March 7, 2016 Type Package Package ccapp March 7, 2016 Title (Robust) Canonical Correlation Analysis via Projection Pursuit Version 0.3.2 Date 2016-03-07 Depends R (>= 3.2.0), parallel, pcapp (>= 1.8-1), robustbase

More information

Package BigVAR. R topics documented: April 3, Type Package

Package BigVAR. R topics documented: April 3, Type Package Type Package Package BigVAR April 3, 2017 Title Dimension Reduction Methods for Multivariate Time Series Version 1.0.2 Date 2017-03-24 Estimates VAR and VARX models with structured Lasso Penalties. Depends

More information

An Introduction to Model-Fitting with the R package glmm

An Introduction to Model-Fitting with the R package glmm An Introduction to Model-Fitting with the R package glmm Christina Knudson November 7, 2017 Contents 1 Introduction 2 2 Formatting the Data 2 3 Fitting the Model 4 4 Reading the Model Summary 6 5 Isolating

More information

Package pnmtrem. February 20, Index 9

Package pnmtrem. February 20, Index 9 Type Package Package pnmtrem February 20, 2015 Title Probit-Normal Marginalized Transition Random Effects Models Version 1.3 Date 2013-05-19 Author Ozgur Asar, Ozlem Ilk Depends MASS Maintainer Ozgur Asar

More information

The exam is closed book, closed notes except your one-page (two-sided) cheat sheet.

The exam is closed book, closed notes except your one-page (two-sided) cheat sheet. CS 189 Spring 2015 Introduction to Machine Learning Final You have 2 hours 50 minutes for the exam. The exam is closed book, closed notes except your one-page (two-sided) cheat sheet. No calculators or

More information

Package EMC. February 19, 2015

Package EMC. February 19, 2015 Package EMC February 19, 2015 Type Package Title Evolutionary Monte Carlo (EMC) algorithm Version 1.3 Date 2011-12-08 Author Gopi Goswami Maintainer Gopi Goswami

More information

Cell based GIS. Introduction to rasters

Cell based GIS. Introduction to rasters Week 9 Cell based GIS Introduction to rasters topics of the week Spatial Problems Modeling Raster basics Application functions Analysis environment, the mask Application functions Spatial Analyst in ArcGIS

More information

Package attrcusum. December 28, 2016

Package attrcusum. December 28, 2016 Type Package Package attrcusum December 28, 2016 Title Tools for Attribute VSI CUSUM Control Chart Version 0.1.0 An implementation of tools for design of attribute variable sampling interval cumulative

More information

Probability and Algorithms Caltech CS150, Winter 2003

Probability and Algorithms Caltech CS150, Winter 2003 Probability and Algorithms Caltech CS150, Winter 2003 Leonard J. Schulman Scribe: Sidharth Jaggi Notes for lecture 13, February 26th, 2003. Dimer Packing Lozenge Tiling Facts Given a simply connected region

More information

Package mnormt. April 2, 2015

Package mnormt. April 2, 2015 Package mnormt April 2, 2015 Version 1.5-2 Date 2015-04-02 Title The Multivariate Normal and t Distributions Author Fortran code by Alan Genz, R code by Adelchi Azzalini Maintainer Adelchi Azzalini

More information

Package spatialtaildep

Package spatialtaildep Package spatialtaildep Title Estimation of spatial tail dependence models February 20, 2015 Provides functions implementing the pairwise M-estimator for parametric models for stable tail dependence functions

More information

survsnp: Power and Sample Size Calculations for SNP Association Studies with Censored Time to Event Outcomes

survsnp: Power and Sample Size Calculations for SNP Association Studies with Censored Time to Event Outcomes survsnp: Power and Sample Size Calculations for SNP Association Studies with Censored Time to Event Outcomes Kouros Owzar Zhiguo Li Nancy Cox Sin-Ho Jung Chanhee Yi June 29, 2016 1 Introduction This vignette

More information

Package intcensroc. May 2, 2018

Package intcensroc. May 2, 2018 Type Package Package intcensroc May 2, 2018 Title Fast Spline Function Based Constrained Maximum Likelihood Estimator for AUC Estimation of Interval Censored Survival Data Version 0.1.1 Date 2018-05-03

More information

Short-Cut MCMC: An Alternative to Adaptation

Short-Cut MCMC: An Alternative to Adaptation Short-Cut MCMC: An Alternative to Adaptation Radford M. Neal Dept. of Statistics and Dept. of Computer Science University of Toronto http://www.cs.utoronto.ca/ radford/ Third Workshop on Monte Carlo Methods,

More information

Package gpr. February 20, 2015

Package gpr. February 20, 2015 Package gpr February 20, 2015 Version 1.1 Date 2013-08-27 Title A Minimalistic package to apply Gaussian Process in R License GPL-3 Author Maintainer ORPHANED Depends R (>= 2.13) This package provides

More information

Markov Chain Monte Carlo (part 1)

Markov Chain Monte Carlo (part 1) Markov Chain Monte Carlo (part 1) Edps 590BAY Carolyn J. Anderson Department of Educational Psychology c Board of Trustees, University of Illinois Spring 2018 Depending on the book that you select for

More information

Package clusternomics

Package clusternomics Type Package Package clusternomics March 14, 2017 Title Integrative Clustering for Heterogeneous Biomedical Datasets Version 0.1.1 Author Evelina Gabasova Maintainer Evelina Gabasova

More information

The pomp Package. July 24, 2007

The pomp Package. July 24, 2007 Type Package Title Partially-observed Markov processes Version 0.17-3 Date 2007-07-23 Author Aaron A. King, Ed Ionides, Carles Breto Maintainer Aaron A. King The pomp Package July 24,

More information

Reinforcement Learning: A brief introduction. Mihaela van der Schaar

Reinforcement Learning: A brief introduction. Mihaela van der Schaar Reinforcement Learning: A brief introduction Mihaela van der Schaar Outline Optimal Decisions & Optimal Forecasts Markov Decision Processes (MDPs) States, actions, rewards and value functions Dynamic Programming

More information

Package lhs. R topics documented: January 4, 2018

Package lhs. R topics documented: January 4, 2018 Package lhs January 4, 2018 Version 0.16 Date 2017-12-23 Title Latin Hypercube Samples Author [aut, cre] Maintainer Depends R (>= 3.3.0) Suggests RUnit Provides a number of methods

More information

Package bayeslongitudinal

Package bayeslongitudinal Type Package Package bayeslongitudinal July 25, 2017 Title Adjust Longitudinal Regression Models Using Bayesian Methodology Version 0.1.0 Date 2017-07-18 Author Edwin Javier Castillo Carreño, Edilberto

More information

Package ADMM. May 29, 2018

Package ADMM. May 29, 2018 Type Package Package ADMM May 29, 2018 Title Algorithms using Alternating Direction Method of Multipliers Version 0.3.0 Provides algorithms to solve popular optimization problems in statistics such as

More information