Package sparsehessianfd

Size: px
Start display at page:

Download "Package sparsehessianfd"

Transcription

1 Type Package Package sparsehessianfd Title Numerical Estimation of Sparse Hessians Version Date Maintainer Michael Braun March 27, 2018 URL Estimates Hessian of a scalar-valued function, and returns it in a sparse Matrix format. The sparsity pattern must be known in advance. The algorithm is especially efficient for hierarchical models with a large number of heterogeneous units. See Braun, M. (2017) <doi: /jss.v082.i10>. License MPL (== 2.0) LazyData true Depends R (>= 3.4.0) Imports Matrix (>= ), methods, Rcpp (>= ) Suggests testthat, numderiv, scales, knitr, xtable, dplyr LinkingTo Rcpp, RcppEigen (>= ) VignetteBuilder knitr SystemRequirements C++11 RoxygenNote NeedsCompilation yes Author Michael Braun [aut, cre, cph] Repository CRAN Date/Publication :53:11 UTC R topics documented: sparsehessianfd-package binary binary-data

2 2 sparsehessianfd-package coloring Coord.to.Pointers deprecated get_colors Matrix.to.Coord Matrix.to.Pointers sparsehessianfd subst Index 14 sparsehessianfd-package Estimate sparse Hessians using finite differences of gradients. Estimate sparse Hessians using finite differences of gradients. The Hessian is returned as a sparse Matrix (dgcmatrix-class). The user supplies the objective function, the gradient, and the row and column indices of the non-zero elements of the lower triangle of the Hessian (i.e., the sparsity structure must be known in advance). In a typical case, you should only need to use the sparsehessianfd initializer, and the fn, gr and hessian methods of the sparsehessian class, and the Matrix.to.Coord utility function. References Braun, Michael sparsehessianfd: An R Package for Estimating Sparse Hessian Matrices. Journal of Statistical Software 82 (10): Coleman, Thomas F, and Jin-Yi Cai The Cyclic Coloring Problem and Estimation of Sparse Hessian Matrices. SIAM Journal on Algebraic Discrete Methods 7 (2): Coleman, Thomas F, Burton S Garbow, and Jorge J More Software for Estimating Sparse Hessian Matrices. ACM Transaction on Mathematical Software 11 (4) (December): Coleman, Thomas F and Jorge J More Estimation of Sparse Hessian Matrices and Graph Coloring Problems. Mathematical Programming 28 (3) (October): Powell, M J D and Ph L Toint On the Estimation of Sparse Hessian Matrices. SIAM Journal on Numerical Analysis 16 (6) (December):

3 binary 3 binary Binary choice example Functions for binary choice example in the vignette. binary.f(p, data, priors, order.row = FALSE) binary.grad(p, data, priors, order.row = FALSE) binary.hess(p, data, priors, order.row = FALSE) P data priors order.row Numeric vector of length (N + 1)k. First Nk elements are heterogeneous coefficients. The remaining k elements are population parameters. Named list of data matrices Y and X, and choice count integer T Named list of matrices inv.omega and inv.sigma Determines order of heterogeneous coefficients in parameter vector. If TRUE, heterogeneous coefficients are ordered by unit. If FALSE, they are ordered by covariate. These functions are used by the heterogeneous binary choice example in the vignette. There are N heterogeneous units, each making T binary choices. The choice probabilities depend on k covariates. Log posterior density, gradient and Hessian. The Hessian is a dgcmatrix object. binary-data Sample simulated data for binary choice example in vignette Sample datasets for vignette

4 4 coloring The package provides four sample datasets for the hierarchical binary choice model described in the vignette. These datasets are: binary N = 50, k = 3 binary_small N = 20, k = 2 binary_large N = 800, k = 3 binary_super N = 1200, k = 3 N is the number of heterogeneous units. k is the number of covariates. The datasets were generated using the code in data-raw/binary_sim.r. coloring Triangular partitioning of variables cyclic coloring from a lower triangular pattern matrix coloring(l) L sparsity pattern of the Hessian as a lower triangular pattern matrix For internal use. Exported in order for replication files for JSS article to run. Integer vector of length nvars with color assignments for each variable.

5 Coord.to.Pointers 5 Coord.to.Pointers Convert a matrix defined by row and column indices to one defined by a row- or column-oriented compression scheme. Returns indices and pointers that define a sparse Hessian in compressed format. Inputs are the row and column indices. Coord.to.Pointers(rows, cols, dims, triangle = TRUE, lower = TRUE, symmetric = FALSE, order = c("column", "row", "triplet"), index1 = TRUE) rows, cols dims triangle lower symmetric order index1 row and column indices of non-zero elements 2-element vector for number of rows and columns. Is input intended to be a triangular (TRUE) or full (FALSE) matrix. See details for how this argument is interpreted for different values of order. If triangular is true, this argument identifies the input matrix as lower- or upper-triangular. This argument is ignored if triangle is FALSE. If TRUE, and matrix is triangular, then the matrix will be treated as symmetric, with only the triangular elements provided. If matrix is neither triangular nor symmetric, then symmetric=true will probably trigger an error. Determines the indexing/compression scheme for the output matrix. Use "triplet" to get row and column indices. Defaults to the same class as M. TRUE if using 1-based indexing. FALSE for 0-based indexing. triangle and order have the following interpretation: triangle=true Input rows and cols represent lower or upper triangle of a matrix. If order="symmetric", then the output list will be for a full, symmetric matrix. Otherwise, the output list will be for only the lower or upper triangle. Any elements outside of the specified triangle will trigger an error. triangle=false Input rows and cols represent a full matrix. If that matrix is not symmetric, then order=="symmetric" will trigger an error. If symmetric=false and order='triplet', the output list should contain the same row and column indices as the input list. A list. See Matrix.to.Pointers (no values are included in return list).

6 6 deprecated See Also Matrix.to.Pointers deprecated Deprecated functions These functions were in earlier versions, but will no longer be maintained, and are not even guaranteed to work now. Build sparse matrix from data in CSC (column compressed) format. Converts row and column indices to a pattern Matrix object of Matrix class This function is deprecated. Use sparsehessianfd instead. Sym.CSC.to.Matrix(H, nvars) Coord.to.Sym.Pattern.Matrix(H, nvars) Coord.to.Pattern.Matrix(rows, cols, dims, compressed = TRUE, symmetric = FALSE, index1 = TRUE) new.sparse.hessian.obj(x, fn, gr, hs, fd.method = 0L, eps = sqrt(.machine$double.eps),...) sparsehessianfd.new(x, fn, gr, rows, cols, direct = NULL, eps = sqrt(.machine$double.eps),...) H nvars rows, cols dims compressed symmetric index1 x fn gr a list containing Hessian data. See details. the number of rows (and columns) in the matrix. row and column indices of non-zero elements 2-element vector for number of rows and columns in matrix If TRUE, returns a matrix is compressed column (default=true) If TRUE, matrix will be symmetric, and only the lower triangular elements need to be provided (default=false) TRUE if input row and col use 1-based indexing, and FALSE for 0-based indexing. variable vector for initialization R function that returns function value R function that returns the gradient of the function

7 get_colors 7 hs fd.method eps list of two vectors: row and column indices of non-zero elements of lower triangle of Hessian. See details. If TRUE, use direct method for computatation. Otherwise, use indirect/substitution method. See references. The perturbation amount for finite differencing of the gradient to compute the Hessian. Defaults to sqrt(.machine$double.eps).... Other parameters to be passed to fn and gr. direct If TRUE, use direct method for computatation. Otherwise, use indirect/substitution method. See references. Use Matrix::sparseMatrix instead of Sym.CSC.to.Matrix. Use Coord.to.Pattern.Matrix with symmetric=true instead of Coord.to.Sym.Pattern.Matrix. This function is useful to prototype a sparsity pattern. No assumptions are made about symmetry. hs is a list of two elements: irow Integer vector of row indices of non-zero elements in lower triangle of Hessian. jcol Integer vector of column indices of non-zero elements in lower triangle of Hessian. This function is deprecated. Use sparsehessianfd instead. An object of Matrix class. A sparse pattern matrix An object of class sparsehessianfd get_colors Vertex coloring of a sparse undirected graph Generate proper vertex coloring of a sparse undirected graph. get_colors(pntr, idx, nvars) pntr, idx nvars row pointers and column indices of the adjacency matrix, in compressed columnoriented format. Must use zero-based indexing. Number of vertices.

8 8 Matrix.to.Coord For internal use. You should not have to call this function directly. An integer vector of length nvars, where each element represents the color of the corresponding vertex. Indices are zero-based. Matrix.to.Coord Row and column indices from sparse matrix. Utility function to extract row and column indices of the non-zero elements of a sparse matrix. Matrix.to.Coord(M, index1 = TRUE) M A matrix that is a subclass of sparsematrix, as defined in the Matrix package. index1 TRUE if the index of the first element should be 1, and FALSE if 0. A wrapper to Matrix.to.Pointers for order='triplet' and values=false, for extracting the row and column indices of a sparsity pattern from a matrix that has that same pattern. A list with two named elements. rows Integer vector containing row indices of non-zero elements cols Integer vector containing column indices of non-zero elements Examples M1 <- as(kronecker(diag(3), matrix(true,2,2)),"sparsematrix") C <- Matrix.to.Coord(M1) M2 <- Matrix::sparseMatrix(i=C$rows, j=c$cols) all.equal(m1,m2)

9 Matrix.to.Pointers 9 Matrix.to.Pointers Extract row and column indices, pointers and values from a sparse matrix. Returns a list of row indices, column indices, pointers, and/or values of a sparse Hessian. Matrix.to.Pointers(M, as.symmetric = Matrix::isSymmetric(M), values =!is(m, "nmatrix"), order = NULL, index1 = TRUE) M as.symmetric values order index1 A sparse Matrix, as defined in the Matrix package. Defaults to issymmetric(m). If M is symmetric, and as.symmetric is FALSE, then index/pointer elements in the output list will be labeled according to order. If M is not symmetric, and as.symmetric is TRUE, then an error will be triggered. If TRUE, values are returned in list as x. Defaults to TRUE for numeric and logical matrices, and FALSE for pattern matrices. If M is a pattern matrix, values=true will trigger a warning. Determines the indexing/compression scheme for the output matrix. Use triplet" to get row and column indices. Defaults to the same class as M. TRUE (default) if return indices and pointers should use 1-based indexing. FALSE for 0-based indexing. This function is included primarily for debugging purposes. It is used internally, but would not ordinarily be called by an end user. A list with the following elements. If order== row, jcol Integer vector containing column indices of non-zero elements ipntr Integer vector containing pointers to elements of jcol at which the next row begins. If order== column irow Integer vector containing row indices of non-zero elements jpntr Integer vector containing pointers to elements of irow at which the next column begins. If order== triplet rows Row indices of non-zero elements

10 10 sparsehessianfd cols Column indices of non-zero elements If as.symmetric is TRUE, then the row/column orientation does not matter. idx Integer vector containing indices of non-zero elements pntr Integer vector containing pointers to elements of idx at which the next row or column begins. If values=true, the return list includes x, the values of the non-zero elements. The class element is the name of the sparse matrix class to which the output corresponds (identifies numeric type, pattern, and indexing/compression scheme). See Also Matrix.to.Coord sparsehessianfd sparsehessianfd A reference class for computing sparse Hessians The sparsehessianfd function calls the initializer for the sparsehessianfd class, and returns a sparsehessianfd object. sparsehessianfd(x, fn, gr, rows, cols, delta, index1, complex,...) The function, gradient and sparsity pattern are declared as part of the initialization. Once initialized, the $hessian method will evaluate the Hessian at x. obj <- sparsehessian(x, fn, gr, rows, cols,...) obj$hessian(x) For convenience, the class provides wrapper methods to the fn and gr functions that were specified in the initializer. obj$fn(p) ## wrapper to objective function obj$gr(p) ## wrapper to gradient obj$fngr(p) ## list of obj function and gradient obj$fngrhs(p) ## list of obj function, gradient and Hessian. to initializer: x an vector at which the function, gradient and Hessian are initialized and tested. fn, gr R functions that return the function value and gradient, evaluated at x. rows, cols Numeric vectors with row and column indices of the non-zero elements in the lower triangle (including diagonal) of the Hessian.

11 sparsehessianfd 11 Fields delta The perturbation amount for finite difference (or complex step) of the gradient to compute the Hessian. Defaults to 1e-07. index1 TRUE if rows and cols use 1-based (R format) indexing (FALSE for 0-based (C format) indexing. complex TRUE if Hessian will be computed using the complex step method, and FALSE (default) if using finite differences. If TRUE, both fn and gr must accept complex arguments and return complex values.... other arguments to be passed to fn and gr. Other methods are described below. Do not access any of the fields directly. The internal structure is subject to change in future versions. fn1 A closure for calling fn(x,...). gr1 A closure for calling gr(x,...). irow,jcol Numeric vectors with row and column indices of the non-zero elements in the lower triangle (including diagonal) of the Hessian. delta The perturbation amount for finite differencing of the gradient to compute the Hessian. Defaults to 1e-07. index1 TRUE if rows and cols use 1-based (R format) indexing (FALSE for 0-based (C format) indexing. complex TRUE if Hessian will be computed using the complex step method, and FALSE (default) if using finite differences. D raw finite differences (internal use only) nvars Number of variables (length of x) nnz Number of non-zero elements in the lower triangle of the Hessian. ready TRUE if object has been initialized, and Hessian has been partitioned. idx,pntr Column indices and row pointers for non-zero elements in lower triangle of the permuted Hessian. Row-oriented compressed storage. colors A vector representation of the partitioning of the columns. There are nvars elements, one for each column of the permuted Hessian. The value corresponds to the "color" for that column. perm,invperm Permutation vector and its inverse Methods fn(x) Return function value, evaluated at x: fn(x,...) fngr(x) Return list of function value and gradient, evaluated at x fngrhs(x) Return list of function value, gradient, and Hessian, evaluated at x get_invperm() Return integer vector of inverse of permutation used for computing Hessian get_nnz() Return number of non-zero elements in lower triangle of Hessian get_nvars() Return dimension (number of rows or columns) of Hessian

12 12 subst get_pattern() Return pattern matrix of lower triangle of Hessian get_perm() Return integer vector of permutation used for computing Hessian get_perm_pattern() Return pattern matrix of lower triangle of *permuted* Hessian gr(x) Return gradient, evaluated at x: gr(x,...) hessian(x) Return sparse Hessian, evaluated at x, as a dgcmatrix object. initialize(x, fn, gr, rows, cols, delta = 1e-07, index1 = TRUE, complex = FALSE,...) Initialize object with functions to compute the objective function and gradient (fn and gr), row and column indices of non-zero elements (rows and cols), an initial variable vector x at which fn and gr can be evaluated, a finite differencing parameter delta, flags for 0 or 1-based indexing (index1), whether the complex step method will be used, and other arguments (...) to be passed to fn and gr. partition() Return the partitioning used to compute finite differences pointers(out.index1 = index1) Return list with indices (idx) and pointers (pntr) for sparsity pattern of the compressed sparse Hessian. Since the Hessian is symmetric, the indices and pointers for row-oriented and column-oriented storage patterns are the same. Examples ## Log posterior density of hierarchical binary choice model. See vignette. set.seed(123) data("binary_small") N <- length(binary[["y"]]) k <- NROW(binary[["X"]]) T <- binary[["t"]] P <- rnorm((n+1)*k) priors <- list(inv.sigma = rwishart(1,k+5,diag(k))[,,1], inv.omega = diag(k)) true.hess <- binary.hess(p, binary, priors) pattern <- Matrix.to.Coord(Matrix::tril(true.hess)) str(pattern) obj <- sparsehessianfd(p, fn=binary.f, gr=binary.grad, rows=pattern[["rows"]], cols=pattern[["cols"]], data=binary, priors=priors) hs <- obj$hessian(p) all.equal(hs, true.hess) f <- obj$fn(p) ## obj function df <- obj$gr(p) ## gradient fdf <- obj$fngr(p) ## list of obj function and gradient fdfhs <- obj$fngrhs(p) ## list of obj function, gradient and Hessian. subst Estimate sparse Hessian Estimate Hessian using triangular subsitution algorithm

13 subst 13 subst(y, colors, jcol, ipntr, delta, nvars, nnz) Y colors jcol, ipntr delta nvars nnz Matrix of finite differences of gradients Vector of length nvars that identifies color of each variable Column indices and row pointers for non-zero elements of lower triangle of Hessian (row-oriented compressed format). Perturbation factor used to compute finite differences of gradients. Dimension of Hessian (number of variables) Number of non-zero elements in the lower triangle of the Hessian. For internal use. You should not have to call this function directly. A sparse Hessian of class dgcmatrix.

14 Index Topic package sparsehessianfd-package, 2 binary, 3 binary-data, 3 binary_large (binary-data), 3 binary_large-data (binary-data), 3 binary_small (binary-data), 3 binary_small-data (binary-data), 3 binary_super (binary-data), 3 binary_super-data (binary-data), 3 coloring, 4 Coord.to.Pattern.Matrix (deprecated), 6 Coord.to.Pointers, 5 Coord.to.Sym.Pattern.Matrix (deprecated), 6 deprecated, 6 get_colors, 7 Matrix.to.Coord, 2, 8 Matrix.to.Pointers, 8, 9 new.sparse.hessian.obj (deprecated), 6 sparsehessianfd, 2, 10 sparsehessianfd-package, 2 sparsehessianfd.new (deprecated), 6 subst, 12 Sym.CSC.to.Matrix (deprecated), 6 14

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

Package nmslibr. April 14, 2018

Package nmslibr. April 14, 2018 Type Package Title Non Metric Space (Approximate) Library Version 1.0.1 Date 2018-04-14 Package nmslibr April 14, 2018 Maintainer Lampros Mouselimis BugReports https://github.com/mlampros/nmslibr/issues

More information

Package readobj. November 2, 2017

Package readobj. November 2, 2017 Type Package Package readobj November 2, 2017 Title Fast Reader for 'Wavefront' OBJ 3D Scene Files Version 0.3 Wraps 'tiny_obj_loader' C++ library for reading the 'Wavefront' OBJ 3D file format including

More information

Package validara. October 19, 2017

Package validara. October 19, 2017 Type Package Title Validate Brazilian Administrative Registers Version 0.1.1 Package validara October 19, 2017 Maintainer Gustavo Coelho Contains functions to validate administrative

More information

Package fastrtext. December 10, 2017

Package fastrtext. December 10, 2017 Type Package Package fastrtext December 10, 2017 Title 'fasttext' Wrapper for Text Classification and Word Representation Version 0.2.4 Date 2017-12-09 Maintainer Michaël Benesty Learning

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 jdx. R topics documented: January 9, Type Package Title 'Java' Data Exchange for 'R' and 'rjava'

Package jdx. R topics documented: January 9, Type Package Title 'Java' Data Exchange for 'R' and 'rjava' Type Package Title 'Java' Data Exchange for 'R' and 'rjava' Package jdx January 9, 2018 Description Simplifies and extends data exchange between 'R' and 'Java'. Version 0.1.0 License GPL (>= 2 BSD_3_clause

More information

Package geojsonsf. R topics documented: January 11, Type Package Title GeoJSON to Simple Feature Converter Version 1.3.

Package geojsonsf. R topics documented: January 11, Type Package Title GeoJSON to Simple Feature Converter Version 1.3. Type Package Title GeoJSON to Simple Feature Converter Version 1.3.0 Date 2019-01-11 Package geojsonsf January 11, 2019 Converts Between GeoJSON and simple feature objects. License GPL-3 Encoding UTF-8

More information

Package ompr. November 18, 2017

Package ompr. November 18, 2017 Type Package Package ompr November 18, 2017 Title Model and Solve Mixed Integer Linear Programs Version 0.7.0 Model mixed integer linear programs in an algebraic way directly in R. The is solver-independent

More information

Package mgc. April 13, 2018

Package mgc. April 13, 2018 Type Package Title Multiscale Graph Correlation Version 1.0.1 Date 2018-04-12 Package mgc April 13, 2018 Maintainer Multiscale Graph Correlation (MGC) is a framework developed by Shen

More information

Package RSpectra. May 23, 2018

Package RSpectra. May 23, 2018 Type Package Package RSpectra May 23, 2018 Title Solvers for Large-Scale Eigenvalue and SVD Problems Version 0.13-1 Date 2018-05-22 Description R interface to the 'Spectra' library

More information

Package reconstructr

Package reconstructr Type Package Title Session Reconstruction and Analysis Version 2.0.2 Date 2018-07-26 Author Oliver Keyes Package reconstructr July 26, 2018 Maintainer Oliver Keyes Functions to reconstruct

More information

Package readxl. April 18, 2017

Package readxl. April 18, 2017 Title Read Excel Files Version 1.0.0 Package readxl April 18, 2017 Import excel files into R. Supports '.xls' via the embedded 'libxls' C library and '.xlsx'

More information

Package kdtools. April 26, 2018

Package kdtools. April 26, 2018 Type Package Package kdtools April 26, 2018 Title Tools for Working with Multidimensional Data Version 0.3.1 Provides various tools for working with multidimensional data in R and C++, including etremely

More information

Package rmumps. September 19, 2017

Package rmumps. September 19, 2017 Type Package Title Wrapper for MUMPS Library Version 5.1.1-3 Date 2017-09-19 Author Serguei Sokol Package rmumps September 19, 2017 Maintainer Serguei Sokol Description Some basic

More information

Package recosystem. September 2, 2017

Package recosystem. September 2, 2017 Type Package Package recosystem September 2, 2017 Title Recommender System using Matrix Factorization Version 0.4.2 Date 2017-09-01 Author Yixuan Qiu, Chih-Jen Lin, Yu-Chin Juan, Wei-Sheng Chin, Yong Zhuang,

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 fastdummies. January 8, 2018

Package fastdummies. January 8, 2018 Type Package Package fastdummies January 8, 2018 Title Fast Creation of Dummy (Binary) Columns and Rows from Categorical Variables Version 1.0.0 Description Creates dummy columns from columns that have

More information

Package widyr. August 14, 2017

Package widyr. August 14, 2017 Type Package Title Widen, Process, then Re-Tidy Data Version 0.1.0 Package widyr August 14, 2017 Encapsulates the pattern of untidying data into a wide matrix, performing some processing, then turning

More information

Package epitab. July 4, 2018

Package epitab. July 4, 2018 Type Package Package epitab July 4, 2018 Title Flexible Contingency Tables for Epidemiology Version 0.2.2 Author Stuart Lacy Maintainer Stuart Lacy Builds contingency tables that

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 fst. December 18, 2017

Package fst. December 18, 2017 Type Package Package fst December 18, 2017 Title Lightning Fast Serialization of Data Frames for R Multithreaded serialization of compressed data frames using the 'fst' format. The 'fst' format allows

More information

Package nngeo. September 29, 2018

Package nngeo. September 29, 2018 Type Package Title k-nearest Neighbor Join for Spatial Data Version 0.2.2 Package nngeo September 29, 2018 K-nearest neighbor search for projected and non-projected 'sf' spatial layers. Nearest neighbor

More information

Package rucrdtw. October 13, 2017

Package rucrdtw. October 13, 2017 Package rucrdtw Type Package Title R Bindings for the UCR Suite Version 0.1.3 Date 2017-10-12 October 13, 2017 BugReports https://github.com/pboesu/rucrdtw/issues URL https://github.com/pboesu/rucrdtw

More information

Package rtext. January 23, 2019

Package rtext. January 23, 2019 Title R6 Objects for Text and Data Date 2019-01-21 Version 0.1.21 Package January 23, 2019 For natural language processing and analysis of qualitative text coding structures which provide a way to bind

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

Package semver. January 6, 2017

Package semver. January 6, 2017 Type Package Title 'Semantic Versioning V2.0.0' Parser Version 0.2.0 Package semver January 6, 2017 Tools and functions for parsing, rendering and operating on semantic version strings. Semantic versioning

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

Package cattonum. R topics documented: May 2, Type Package Version Title Encode Categorical Features

Package cattonum. R topics documented: May 2, Type Package Version Title Encode Categorical Features Type Package Version 0.0.2 Title Encode Categorical Features Package cattonum May 2, 2018 Functions for dummy encoding, frequency encoding, label encoding, leave-one-out encoding, mean encoding, median

More information

Package Rtsne. April 14, 2017

Package Rtsne. April 14, 2017 Type Package Package Rtsne April 14, 2017 Title T-Distributed Stochastic Neighbor Embedding using a Barnes-Hut Implementation Version 0.13 Description An R wrapper around the fast T-distributed Stochastic

More information

trustoptim: an R Package for Trust Region Optimization with Sparse Hessians

trustoptim: an R Package for Trust Region Optimization with Sparse Hessians trustoptim: an R Package for Trust Region Optimization with Sparse Hessians Michael Braun MIT Sloan School of Management Massachusetts Institute of Technology December 27, 2012 Abstract Trust region algorithms

More information

Package apastyle. March 29, 2017

Package apastyle. March 29, 2017 Type Package Title Generate APA Tables for MS Word Version 0.5 Date 2017-03-29 Author Jort de Vreeze [aut, cre] Package apastyle March 29, 2017 Maintainer Jort de Vreeze Most

More information

Package exporkit. R topics documented: May 5, Type Package Title Expokit in R Version Date

Package exporkit. R topics documented: May 5, Type Package Title Expokit in R Version Date Type Package Title Expokit in R Version 0.9.2 Date 2018-05-04 Package exporkit May 5, 2018 Maintainer Niels Richard Hansen Depends R (>= 2.14.1), methods Imports Matrix, SparseM

More information

Package tropicalsparse

Package tropicalsparse Type Package Title Sparse Tropical Algebra Version 0.1.0 Date 2018-06-25 Package tropicalsparse July 1, 2018 Some of the basic tropical algebra functionality is provided for sparse matrices by applying

More information

Package datasets.load

Package datasets.load Title Interface for Loading Datasets Version 0.1.0 Package datasets.load December 14, 2016 Visual interface for loading datasets in RStudio from insted (unloaded) s. Depends R (>= 3.0.0) Imports shiny,

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 tidyselect. October 11, 2018

Package tidyselect. October 11, 2018 Title Select from a Set of Strings Version 0.2.5 Package tidyselect October 11, 2018 A backend for the selecting functions of the 'tidyverse'. It makes it easy to implement select-like functions in your

More information

Package robotstxt. November 12, 2017

Package robotstxt. November 12, 2017 Date 2017-11-12 Type Package Package robotstxt November 12, 2017 Title A 'robots.txt' Parser and 'Webbot'/'Spider'/'Crawler' Permissions Checker Version 0.5.2 Provides functions to download and parse 'robots.txt'

More information

Package diffusr. May 17, 2018

Package diffusr. May 17, 2018 Type Package Title Network Diffusion Algorithms Version 0.1.4 Date 2018-04-20 Package diffusr May 17, 2018 Maintainer Simon Dirmeier Implementation of network diffusion algorithms

More information

Package tibble. August 22, 2017

Package tibble. August 22, 2017 Encoding UTF-8 Version 1.3.4 Title Simple Data Frames Package tibble August 22, 2017 Provides a 'tbl_df' class (the 'tibble') that provides stricter checking and better formatting than the traditional

More information

Package bisect. April 16, 2018

Package bisect. April 16, 2018 Package bisect April 16, 2018 Title Estimating Cell Type Composition from Methylation Sequencing Data Version 0.9.0 Maintainer Eyal Fisher Author Eyal Fisher [aut, cre] An implementation

More information

Package spark. July 21, 2017

Package spark. July 21, 2017 Title 'Sparklines' in the 'R' Terminal Version 2.0.0 Author Gábor Csárdi Package spark July 21, 2017 Maintainer Gábor Csárdi A 'sparkline' is a line chart, without axes and labels.

More information

Package crossword.r. January 19, 2018

Package crossword.r. January 19, 2018 Date 2018-01-13 Type Package Title Generating s from Word Lists Version 0.3.5 Author Peter Meissner Package crossword.r January 19, 2018 Maintainer Peter Meissner Generate crosswords

More information

Package postgistools

Package postgistools Type Package Package postgistools March 28, 2018 Title Tools for Interacting with 'PostgreSQL' / 'PostGIS' Databases Functions to convert geometry and 'hstore' data types from 'PostgreSQL' into standard

More information

Package ECOSolveR. February 18, 2018

Package ECOSolveR. February 18, 2018 Package ECOSolveR Type Package Title Embedded Conic Solver in R Version 0.4 Date 2018-02-16 VignetteBuilder knitr SystemRequirements GNU make February 18, 2018 URL https://github.com/bnaras/ecosolver BugReports

More information

Package filematrix. R topics documented: February 27, Type Package

Package filematrix. R topics documented: February 27, Type Package Type Package Package filematrix February 27, 2018 Title File-Backed Matrix Class with Convenient Read and Write Access Version 1.3 Date 2018-02-26 Description Interface for working with large matrices

More information

Package crossrun. October 8, 2018

Package crossrun. October 8, 2018 Version 0.1.0 Package crossrun October 8, 2018 Title Joint Distribution of Number of Crossings and Longest Run Joint distribution of number of crossings and the longest run in a series of independent Bernoulli

More information

Package wrswor. R topics documented: February 2, Type Package

Package wrswor. R topics documented: February 2, Type Package Type Package Package wrswor February 2, 2018 Title Weighted Random Sampling without Replacement Version 1.1 Date 2018-02-02 Description A collection of implementations of classical and novel algorithms

More information

Package docxtools. July 6, 2018

Package docxtools. July 6, 2018 Title Tools for R Markdown to Docx Documents Version 0.2.0 Language en-us Package docxtools July 6, 2018 A set of helper functions for using R Markdown to create documents in docx format, especially documents

More information

Package coga. May 8, 2018

Package coga. May 8, 2018 Title Convolution of Gamma Distributions Version 1.0.0 Date 2018-05-08 Package coga May 8, 2018 Evaluation for density and distribution function of convolution of gamma distributions in R. Two related

More information

Package mmpa. March 22, 2017

Package mmpa. March 22, 2017 Type Package Package mmpa March 22, 2017 Title Implementation of Marker-Assisted Mini-Pooling with Algorithm Version 0.1.0 Author ``Tao Liu [aut, cre]'' ``Yizhen Xu

More information

Package farver. November 20, 2018

Package farver. November 20, 2018 Type Package Package farver November 20, 2018 Title Vectorised Colour Conversion and Comparison Version 1.1.0 Date 2018-11-20 Maintainer Thomas Lin Pedersen The encoding of colour

More information

Package sfc. August 29, 2016

Package sfc. August 29, 2016 Type Package Title Substance Flow Computation Version 0.1.0 Package sfc August 29, 2016 Description Provides a function sfc() to compute the substance flow with the input files --- ``data'' and ``model''.

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

Package BiocManager. November 13, 2018

Package BiocManager. November 13, 2018 Package BiocManager November 13, 2018 Title Access the Bioconductor Project Package Repository A convenient tool to install and update Bioconductor packages. Version 1.30.4 Depends R (>= 3.5.0) Imports

More information

Package WordR. September 7, 2017

Package WordR. September 7, 2017 Type Package Package WordR September 7, 2017 Title Rendering Word Documents with R Inline Code Version 0.2.2 Author Tomas Hovorka Maintainer Tomas Hovorka Serves for rendering

More information

Package optimus. March 24, 2017

Package optimus. March 24, 2017 Type Package Package optimus March 24, 2017 Title Model Based Diagnostics for Multivariate Cluster Analysis Version 0.1.0 Date 2017-03-24 Maintainer Mitchell Lyons Description

More information

Package pkgbuild. October 16, 2018

Package pkgbuild. October 16, 2018 Title Find Tools Needed to Build R Packages Version 1.0.2 Package pkgbuild October 16, 2018 Provides functions used to build R packages. Locates compilers needed to build R packages on various platforms

More information

Package triebeard. August 29, 2016

Package triebeard. August 29, 2016 Type Package Title 'Radix' Trees in 'Rcpp' Version 0.3.0 Package beard August 29, 2016 Author Oliver Keyes [aut, cre], Drew Schmidt [aut], Yuuki Takano [cph] Maintainer Oliver Keyes

More information

Package msda. February 20, 2015

Package msda. February 20, 2015 Title Multi-Class Sparse Discriminant Analysis Version 1.0.2 Date 2014-09-26 Package msda February 20, 2015 Author Maintainer Yi Yang Depends Matri, MASS Efficient procedures for computing

More information

Package svd. R topics documented: September 26, 2017

Package svd. R topics documented: September 26, 2017 Package svd September 26, 2017 Type Package Imports methods Suggests testthat (>= 0.7) Title Interfaces to Various State-of-Art SVD and Eigensolvers Version 0.4.1 Author Anton Korobeynikov [aut, cre],

More information

Package FSelectorRcpp

Package FSelectorRcpp Type Package Package FSelectorRcpp November 12, 2018 Title 'Rcpp' Implementation of 'FSelector' Entropy-Based Feature Selection Algorithms with a Sparse Matrix Support Version 0.3.0 Description 'Rcpp'

More information

Package jpmesh. December 4, 2017

Package jpmesh. December 4, 2017 Type Package Title Utilities for Japanese Mesh Code Version 1.0.1 Package jpmesh December 4, 2017 Maintainer Shinya Uryu Helpful functions for using mesh code (80km to 125m) data

More information

Package paralleldist

Package paralleldist Type Package Package paralleldist December 5, 2017 Title Parallel Distance Matrix Computation using Multiple Threads Version 0.2.1 Author Alexander Eckert [aut, cre] Maintainer Alexander Eckert

More information

Package oec. R topics documented: May 11, Type Package

Package oec. R topics documented: May 11, Type Package Type Package Package oec May 11, 2018 Title Observatory of Economic Complexity API Wrapper and Utility Program Version 2.7.8 Date 2018-06-11 Maintainer Mauricio Vargas S. URL https://cran.r-project.org/package=oec

More information

Package assortnet. January 18, 2016

Package assortnet. January 18, 2016 Type Package Package assortnet January 18, 2016 Title Calculate the Assortativity Coefficient of Weighted and Binary Networks Version 0.12 Date 2016-01-18 Author Damien Farine Maintainer

More information

Package eply. April 6, 2018

Package eply. April 6, 2018 Type Package Title Apply a Function Over Expressions Version 0.1.2 Package eply April 6, 2018 Evaluate a function over a data frame of expressions. License GPL-3 Depends R (>= 3.0.0) Imports magrittr,

More information

Package fst. June 7, 2018

Package fst. June 7, 2018 Type Package Package fst June 7, 2018 Title Lightning Fast Serialization of Data Frames for R Multithreaded serialization of compressed data frames using the 'fst' format. The 'fst' format allows for random

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

Package Rsomoclu. January 3, 2019

Package Rsomoclu. January 3, 2019 Package Rsomoclu Version 1.7.5.3 Date 2019-01-03 Title Somoclu Imports kohonen January 3, 2019 Suggests Description Somoclu is a massively parallel implementation of self-organizing maps. It exploits multicore

More information

Package vinereg. August 10, 2018

Package vinereg. August 10, 2018 Type Package Title D-Vine Quantile Regression Version 0.5.0 Package vinereg August 10, 2018 Maintainer Thomas Nagler Description Implements D-vine quantile regression models with parametric

More information

Package modmarg. R topics documented:

Package modmarg. R topics documented: Package modmarg February 1, 2018 Title Calculating Marginal Effects and Levels with Errors Version 0.9.2 Calculate predicted levels and marginal effects, using the delta method to calculate standard errors.

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

Package narray. January 28, 2018

Package narray. January 28, 2018 Package narray January 28, 2018 Title Subset- And Name-Aware Array Utility Functions Version 0.4.0 Author Michael Schubert Maintainer Michael Schubert Stacking

More information

Package meshsimp. June 13, 2017

Package meshsimp. June 13, 2017 Package meshsimp June 13, 2017 Version 0.1.1 Date 2017-06-09 Title Simplification of Surface Triangular Meshes with Associated Distributed Data Author Franco Dassi [aut], Bree Ettinger [aut], Marco Martinolli

More information

Package canvasxpress

Package canvasxpress Version 1.18.2 Package canvasxpress Title Visualization Package for CanvasXpress in R January 19, 2018 Enables creation of visualizations using the CanvasXpress framework in R. CanvasXpress is a standalone

More information

Package geoops. March 19, 2018

Package geoops. March 19, 2018 Type Package Package geoops March 19, 2018 Title 'GeoJSON' Topology Calculations and Operations Tools for doing calculations and manipulations on 'GeoJSON', a 'geospatial' data interchange format ().

More information

Package censusapi. August 19, 2018

Package censusapi. August 19, 2018 Version 0.4.1 Title Retrieve Data from the Census APIs Package censusapi August 19, 2018 A wrapper for the U.S. Census Bureau APIs that returns data frames of Census data and metadata. Available datasets

More information

Package ggimage. R topics documented: December 5, Title Use Image in 'ggplot2' Version 0.1.0

Package ggimage. R topics documented: December 5, Title Use Image in 'ggplot2' Version 0.1.0 Title Use Image in 'ggplot2' Version 0.1.0 Package ggimage December 5, 2017 Supports image files and graphic objects to be visualized in 'ggplot2' graphic system. Depends R (>= 3.3.0), ggplot2 Imports

More information

Package elmnnrcpp. July 21, 2018

Package elmnnrcpp. July 21, 2018 Type Package Title The Extreme Learning Machine Algorithm Version 1.0.1 Date 2018-07-21 Package elmnnrcpp July 21, 2018 BugReports https://github.com/mlampros/elmnnrcpp/issues URL https://github.com/mlampros/elmnnrcpp

More information

Package understandbpmn

Package understandbpmn Type Package Package understandbpmn June 8, 2018 Title Calculator of Understandability Metrics for BPMN Version 1.1.0 Author Jonas Lieben Maintainer Jonas Lieben Calculate several

More information

Package quadprogxt. February 4, 2018

Package quadprogxt. February 4, 2018 Package quadprogxt February 4, 2018 Title Quadratic Programming with Absolute Value Constraints Version 0.0.2 Description Extends the quadprog package to solve quadratic programs with absolute value constraints

More information

Package messaging. May 27, 2018

Package messaging. May 27, 2018 Type Package Package messaging May 27, 2018 Title Conveniently Issue Messages, Warnings, and Errors Version 0.1.0 Description Provides tools for creating and issuing nicely-formatted text within R diagnostic

More information

Package reticulate. November 24, 2017

Package reticulate. November 24, 2017 Type Package Title R Interface to Python Version 1.3.1 Package reticulate November 24, 2017 R interface to Python modules, classes, and functions. When calling into Python R data types are automatically

More information

Package projector. February 27, 2018

Package projector. February 27, 2018 Package projector February 27, 2018 Title Project Dense Vectors Representation of Texts on a 2D Plan Version 0.0.2 Date 2018-02-27 Maintainer Michaël Benesty Display dense vector representation

More information

Package slam. December 1, 2016

Package slam. December 1, 2016 Version 0.1-40 Title Sparse Lightweight Arrays and Matrices Package slam December 1, 2016 Data structures and algorithms for sparse arrays and matrices, based on inde arrays and simple triplet representations,

More information

Package simsurv. May 18, 2018

Package simsurv. May 18, 2018 Type Package Title Simulate Survival Data Version 0.2.2 Date 2018-05-18 Package simsurv May 18, 2018 Maintainer Sam Brilleman Description Simulate survival times from standard

More information

Package sfdct. August 29, 2017

Package sfdct. August 29, 2017 Package sfdct August 29, 2017 Title Constrained Triangulation for Simple Features Version 0.0.4 Build a constrained 'Delaunay' triangulation from simple features objects, applying constraints based on

More information

Package kdevine. May 19, 2017

Package kdevine. May 19, 2017 Type Package Package kdevine May 19, 2017 Title Multivariate Kernel Density Estimation with Vine Copulas Version 0.4.1 Date 2017-05-20 URL https://github.com/tnagler/kdevine BugReports https://github.com/tnagler/kdevine/issues

More information

Package inca. February 13, 2018

Package inca. February 13, 2018 Type Package Title Integer Calibration Version 0.0.3 Date 2018-02-09 Package inca February 13, 2018 Author Luca Sartore and Kelly Toppin Maintainer

More information

Package ggimage. R topics documented: November 1, Title Use Image in 'ggplot2' Version 0.0.7

Package ggimage. R topics documented: November 1, Title Use Image in 'ggplot2' Version 0.0.7 Title Use Image in 'ggplot2' Version 0.0.7 Package ggimage November 1, 2017 Supports image files and graphic objects to be visualized in 'ggplot2' graphic system. Depends R (>= 3.3.0), ggplot2 Imports

More information

Package sigqc. June 13, 2018

Package sigqc. June 13, 2018 Title Quality Control Metrics for Gene Signatures Version 0.1.20 Package sigqc June 13, 2018 Description Provides gene signature quality control metrics in publication ready plots. Namely, enables the

More information

Package shinyfeedback

Package shinyfeedback Type Package Package shinyfeedback August 20, 2018 Title Displays User Feedback Next to Shiny Inputs Version 0.1.0 Date 2018-08-19 Easily display user feedback next to Shiny inputs. The feedback message

More information

Package Rcsdp. April 25, 2016

Package Rcsdp. April 25, 2016 Package Rcsdp April 25, 2016 Version 0.1.55 Title R Interface to the CSDP Semidefinite Programming Library Author Hector Corrada Bravo (CSDP by Brian Borchers) Maintainer Hector Corrada Bravo

More information

Package rmatio. July 28, 2017

Package rmatio. July 28, 2017 Title Read and Write 'Matlab' Files Version 0.12.0 Package rmatio July 28, 2017 Description Read and write 'Matlab' MAT files from R. The 'rmatio' package supports reading MAT version 4, MAT version 5

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 rmumps. December 18, 2017

Package rmumps. December 18, 2017 Type Package Title Wrapper for MUMPS Library Version 5.1.2-2 Date 2017-12-13 Package rmumps December 18, 2017 Maintainer Serguei Sokol Description Some basic features of MUMPS

More information

Package reval. May 26, 2015

Package reval. May 26, 2015 Package reval May 26, 2015 Title Repeated Function Evaluation for Sensitivity Analysis Version 2.0.0 Date 2015-05-25 Author Michael C Koohafkan [aut, cre] Maintainer Michael C Koohafkan

More information

Package splithalf. March 17, 2018

Package splithalf. March 17, 2018 Type Package Package splithalf March 17, 2018 Title Calculate Task Split Half Reliability Estimates Version 0.3.1 Maintainer Sam Parsons A series of functions to calculate the

More information

Package d3heatmap. February 1, 2018

Package d3heatmap. February 1, 2018 Type Package Package d3heatmap February 1, 2018 Title Interactive Heat Maps Using 'htmlwidgets' and 'D3.js' Version 0.6.1.2 Date 2016-02-23 Maintainer ORPHANED Description Create interactive heat maps

More information