 
 
 
The previous toolbox we have presented is well adapted for solving a large number of small and medium-scale sparse decomposition problems with the square loss, which is typical from the classical dictionary learning framework. We now present a new software package that is adapted for solving a wide range of possibly large-scale learning problems, with several combinations of losses and regularization terms. The method implements the proximal methods of [1], and includes the proximal solvers for the tree-structured regularization of [15], and the solver of [22] for general structured sparse regularization. The solver for structured sparse regularization norms includes a C++ max-flow implementation of the push-relabel algorithm of [13], with heuristics proposed by [5].
This implementation also provides robust stopping criteria based on duality gaps, which are presented in Appendix A. It can handle intercepts (unregularized variables). The general formulation that our software can solve take the form
| 
 | [g(w) | 
 | f(w) + λψ(w)], | 
where f is a smooth loss function and ψ is a regularization function. When one optimizes a matrix W in ℝp × r instead of a vector w in ℝp, we will write
| 
 | [g(W) | 
 | f(W) + λψ(W)]. | 
Note that the software can possibly handle nonnegativity constraints.
We start by presenting the type of regularization implemented in the software
Our software can handle the following regularization functions ψ for vectors w in ℝp:
Our software also handles regularization functions ψ on matrices W in ℝp × r (note that W can be transposed in these formulations). In particular,
| ψ(W) | 
 | 
 | 
 | ηg||wgi||∞+ γ | 
 | ηg | 
 | ||Wj||∞, (25) | 
Non-convex regularizations are also implemented with the ISTA algorithm (no duality gaps are of course provided in these cases):
All of these regularization terms for vectors or matrices can be coupled with nonnegativity constraints. It is also possible to add an intercept, which one wishes not to regularize, and we will include this possibility in the next sections. There are also a few hidden undocumented options which are available in the source code.
We now present 3 functions for computing proximal operators associated to the previous regularization functions.
This function computes the proximal operators associated to many regularization functions, for input signals U=[u1,…,un] in ℝp × n, it finds a matrix V=[v1,…,vn] in ℝp × n such that:
• If one chooses a regularization function on vectors, for every column u of U, it computes one column v of V solving
| 
 | 
 | ||u−v||22 + λ ||v||0, (26) | 
or
| 
 | 
 | ||u−v||22 + λ ||v||1, (27) | 
or
| 
 | 
 | ||u−v||22 + | 
 | ||v||22, (28) | 
or
| 
 | 
 | ||u−v||22 + λ ||v||1 + λ2||v||22, (29) | 
or
| 
 | 
 | ||u−v||22 + λ | 
 | |vj+1i−vji|+λ2 ||v||1 + λ3||v||22, (30) | 
or
| 
 | 
 | ||u−v||22 + λ | 
 | δg(v), (31) | 
where T is a tree-structured set of groups (see [16]), and δg(v) = 0 if vg=0 and 1 otherwise. It can also solve
| 
 | 
 | ||u−v||22 + λ | 
 | ηg ||vg||2, (32) | 
or
| 
 | 
 | ||u−v||22 + λ | 
 | ηg ||vg||∞, (33) | 
or
| 
 | 
 | ||u−v||22 + λ | 
 | ηg ||vg||∞, (34) | 
where G is any kind of set of groups.
This function can also solve the following proximal operators on matrices
| 
 | 
 | ||U−V||F2 + λ | 
 | ||Vi||2, (35) | 
where Vi is the i-th row of V, or
| 
 | 
 | ||U−V||F2 + λ | 
 | ||Vi||∞, (36) | 
or
| 
 | 
 | ||U−V||F2 + λ | 
 | ||Vi||2 +λ2 | 
 | 
 | |Vij|, (37) | 
or
| 
 | 
 | ||U−V||F2 + λ | 
 | ||Vi||∞+λ2 | 
 | 
 | |Vij|, (38) | 
or
| 
 | 
 | ||U−V||F2 + λ | 
 | ||Vi||∞+λ2 | 
 | ||Vj||∞. (39) | 
where Vj is the j-th column of V.
See details below:
| # # Name: proximalFlat # # Usage: spams.proximalFlat(U,return_val_loss = False,numThreads =-1,lambda1=1.0,lambda2=0., # lambda3=0.,intercept=False,resetflow=False,regul="",verbose=False, # pos=False,clever=True,size_group=1,groups = None,transpose=False) # # Description: # proximalFlat computes proximal operators. Depending # on the value of regul, it computes # # Given an input matrix U=[u^1,\ldots,u^n], it computes a matrix # V=[v^1,\ldots,v^n] such that # if one chooses a regularization functions on vectors, it computes # for each column u of U, a column v of V solving # if regul='l0' # argmin 0.5||u-v||_2^2 + lambda1||v||_0 # if regul='l1' # argmin 0.5||u-v||_2^2 + lambda1||v||_1 # if regul='l2' # argmin 0.5||u-v||_2^2 + 0.5lambda1||v||_2^2 # if regul='elastic-net' # argmin 0.5||u-v||_2^2 + lambda1||v||_1 + lambda1_2||v||_2^2 # if regul='fused-lasso' # argmin 0.5||u-v||_2^2 + lambda1 FL(v) + ... # ... lambda1_2||v||_1 + lambda1_3||v||_2^2 # if regul='linf' # argmin 0.5||u-v||_2^2 + lambda1||v||_inf # if regul='l1-constraint' # argmin 0.5||u-v||_2^2 s.t. ||v||_1 <= lambda1 # if regul='l2-not-squared' # argmin 0.5||u-v||_2^2 + lambda1||v||_2 # if regul='group-lasso-l2' # argmin 0.5||u-v||_2^2 + lambda1 sum_g ||v_g||_2 # where the groups are either defined by groups or by size_group, # if regul='group-lasso-linf' # argmin 0.5||u-v||_2^2 + lambda1 sum_g ||v_g||_inf # if regul='sparse-group-lasso-l2' # argmin 0.5||u-v||_2^2 + lambda1 sum_g ||v_g||_2 + lambda1_2 ||v||_1 # where the groups are either defined by groups or by size_group, # if regul='sparse-group-lasso-linf' # argmin 0.5||u-v||_2^2 + lambda1 sum_g ||v_g||_inf + lambda1_2 ||v||_1 # if regul='trace-norm-vec' # argmin 0.5||u-v||_2^2 + lambda1 ||mat(v)||_* # where mat(v) has size_group rows # # if one chooses a regularization function on matrices # if regul='l1l2', V= # argmin 0.5||U-V||_F^2 + lambda1||V||_{1/2} # if regul='l1linf', V= # argmin 0.5||U-V||_F^2 + lambda1||V||_{1/inf} # if regul='l1l2+l1', V= # argmin 0.5||U-V||_F^2 + lambda1||V||_{1/2} + lambda1_2||V||_{1/1} # if regul='l1linf+l1', V= # argmin 0.5||U-V||_F^2 + lambda1||V||_{1/inf} + lambda1_2||V||_{1/1} # if regul='l1linf+row-column', V= # argmin 0.5||U-V||_F^2 + lambda1||V||_{1/inf} + lambda1_2||V'||_{1/inf} # if regul='trace-norm', V= # argmin 0.5||U-V||_F^2 + lambda1||V||_* # if regul='rank', V= # argmin 0.5||U-V||_F^2 + lambda1 rank(V) # if regul='none', V= # argmin 0.5||U-V||_F^2 # # for all these regularizations, it is possible to enforce non-negativity constraints # with the option pos, and to prevent the last row of U to be regularized, with # the option intercept # # Inputs: # U: double m x n matrix (input signals) # m is the signal size # return_val_loss: # if true the function will return a tuple of matrices. # lambda1: (regularization parameter) # regul: (choice of regularization, see above) # lambda2: (optional, regularization parameter) # lambda3: (optional, regularization parameter) # verbose: (optional, verbosity level, false by default) # intercept: (optional, last row of U is not regularized, # false by default) # transpose: (optional, transpose the matrix in the regularization function) # size_group: (optional, for regularization functions assuming a group # structure). It is a scalar. When groups is not specified, it assumes # that the groups are the sets of consecutive elements of size size_group # groups: (int32, optional, for regularization functions assuming a group # structure. It is an int32 vector of size m containing the group indices of the # variables (first group is 1). # pos: (optional, adds positivity constraints on the # coefficients, false by default) # numThreads: (optional, number of threads for exploiting # multi-core / multi-cpus. By default, it takes the value -1, # which automatically selects all the available CPUs/cores). # resetflow: undocumented; modify at your own risks! # clever: undocumented; modify at your own risks! # # Output: # V: double m x n matrix (output coefficients) # val_regularizer: double 1 x n vector (value of the regularization # term at the optimum). # val_loss: vector of size U.shape[1] # alpha = spams.proximalFlat(U,return_val_loss = False,...) # (alpha,val_loss) = spams.proximalFlat(U,return_val_loss = True,...) # # Authors: # Julien MAIRAL, 2010 (spams, matlab interface and documentation) # Jean-Paul CHIEZE 2011-2012 (python interface) # # Note: # Valid values for the regularization parameter (regul) are: # "l0", "l1", "l2", "linf", "l2-not-squared", "elastic-net", "fused-lasso", # "group-lasso-l2", "group-lasso-linf", "sparse-group-lasso-l2", # "sparse-group-lasso-linf", "l1l2", "l1linf", "l1l2+l1", "l1linf+l1", # "tree-l0", "tree-l2", "tree-linf", "graph", "graph-ridge", "graph-l2", # "multi-task-tree", "multi-task-graph", "l1linf-row-column", "trace-norm", # "trace-norm-vec", "rank", "rank-vec", "none" # | 
The following piece of code illustrates how to use this function. The following piece of code contains usage examples:
| import spams import numpy as np param = {'numThreads' : -1,'verbose' : True, 'lambda1' : 0.1 } m = 100;n = 1000 U = np.asfortranarray(np.random.normal(size = (m,n)),dtype=myfloat) # test L0 print "\nprox l0" param['regul'] = 'l0' param['pos'] = False # false by default param['intercept'] = False # false by default alpha = spams.proximalFlat(U,False,**param) # test L1 print "\nprox l1, intercept, positivity constraint" param['regul'] = 'l1' param['pos'] = True # can be used with all the other regularizations param['intercept'] = True # can be used with all the other regularizations alpha = spams.proximalFlat(U,False,**param) # test L2 print "\nprox squared-l2" param['regul'] = 'l2' param['pos'] = False param['intercept'] = False alpha = spams.proximalFlat(U,False,**param) # test elastic-net print "\nprox elastic-net" param['regul'] = 'elastic-net' param['lambda2'] = 0.1 alpha = spams.proximalFlat(U,**param) # test fused-lasso print "\nprox fused lasso" param['regul'] = 'fused-lasso' param['lambda2'] = 0.1 param['lambda3'] = 0.1 alpha = spams.proximalFlat(U,**param) # test l1l2 print "\nprox mixed norm l1/l2" param['regul'] = 'l1l2' alpha = spams.proximalFlat(U,**param) # test l1linf print "\nprox mixed norm l1/linf" param['regul'] = 'l1linf' alpha = spams.proximalFlat(U,**param) # test l1l2+l1 print "\nprox mixed norm l1/l2 + l1" param['regul'] = 'l1l2+l1' param['lambda2'] = 0.1 alpha = spams.proximalFlat(U,**param) # test l1linf+l1 print "\nprox mixed norm l1/linf + l1" param['regul'] = 'l1linf+l1' param['lambda2'] = 0.1 alpha = spams.proximalFlat(U,**param) # test l1linf-row-column print "\nprox mixed norm l1/linf on rows and columns" param['regul'] = 'l1linf-row-column' param['lambda2'] = 0.1 alpha = spams.proximalFlat(U,**param) # test none print "\nprox no regularization" param['regul'] = 'none' alpha = spams.proximalFlat(U,**param) | 
This function computes the proximal operators associated to tree-structured regularization functions, for input signals U=[u1,…,un] in ℝp × n, and a tree-structured set of groups [15], it computes a matrix V=[v1,…,vn] in ℝp × n. When one uses a regularization function on vectors, it computes a column v of V for every column u of U:
| 
 | 
 | ||u−v||22 + λ | 
 | ηg ||vg||2, (40) | 
or
| 
 | 
 | ||u−v||22 + λ | 
 | ηg ||vg||∞, (41) | 
or
| 
 | 
 | ||u−v||22 + λ | 
 | δg(v), (42) | 
where δg(v)=0 if vg=0 and 1 otherwise (see appendix of [16]).
When the multi-task tree-structured regularization function is used, it solves
| 
 | 
 | ||U−V||F2 + λ | 
 | 
 | ηg ||vgi||∞+ λ2 | 
 | 
 | ||vgj||∞, (43) | 
which is a formulation presented in [22].
This function can also be used for computing the proximal operators addressed by spams.proximalFlat (it will just not take into account the tree structure). The way the tree is incoded is presented below, (and examples are given in the file test_ProximalTree.m, with more usage details:
| # # Name: proximalTree # # Usage: spams.proximalTree(U,tree,return_val_loss = False,numThreads =-1,lambda1=1.0,lambda2=0., # lambda3=0.,intercept=False,resetflow=False,regul="",verbose=False, # pos=False,clever=True,size_group=1,transpose=False) # # Description: # proximalTree computes a proximal operator. Depending # on the value of regul, it computes # # Given an input matrix U=[u^1,\ldots,u^n], and a tree-structured set of groups T, # it returns a matrix V=[v^1,\ldots,v^n]: # # when the regularization function is for vectors, # for every column u of U, it compute a column v of V solving # if regul='tree-l0' # argmin 0.5||u-v||_2^2 + lambda1 \sum_{g \in T} \delta^g(v) # if regul='tree-l2' # for all i, v^i = # argmin 0.5||u-v||_2^2 + lambda1\sum_{g \in T} \eta_g||v_g||_2 # if regul='tree-linf' # for all i, v^i = # argmin 0.5||u-v||_2^2 + lambda1\sum_{g \in T} \eta_g||v_g||_inf # # when the regularization function is for matrices: # if regul='multi-task-tree' # V=argmin 0.5||U-V||_F^2 + lambda1 \sum_{i=1}^n\sum_{g \in T} \eta_g||v^i_g||_inf + ... # lambda1_2 \sum_{g \in T} \eta_g max_{j in g}||V_j||_{inf} # # it can also be used with any non-tree-structured regularization addressed by proximalFlat # # for all these regularizations, it is possible to enforce non-negativity constraints # with the option pos, and to prevent the last row of U to be regularized, with # the option intercept # # Inputs: # U: double m x n matrix (input signals) # m is the signal size # tree: named list # with four fields, eta_g, groups, own_variables and N_own_variables. # # The tree structure requires a particular organization of groups and variables # * Let us denote by N = |T|, the number of groups. # the groups should be ordered T={g1,g2,\ldots,gN} such that if gi is included # in gj, then j <= i. g1 should be the group at the root of the tree # and contains every variable. # * Every group is a set of contiguous indices for instance # gi={3,4,5} or gi={4,5,6,7} or gi={4}, but not {3,5}; # * We define root(gi) as the indices of the variables that are in gi, # but not in its descendants. For instance for # T={ g1={1,2,3,4},g2={2,3},g3={4} }, then, root(g1)={1}, # root(g2)={2,3}, root(g3)={4}, # We assume that for all i, root(gi) is a set of contigous variables # * We assume that the smallest of root(gi) is also the smallest index of gi. # # For instance, # T={ g1={1,2,3,4},g2={2,3},g3={4} }, is a valid set of groups. # but we can not have # T={ g1={1,2,3,4},g2={1,2},g3={3} }, since root(g1)={4} and 4 is not the # smallest element in g1. # # We do not lose generality with these assumptions since they can be fullfilled for any # tree-structured set of groups after a permutation of variables and a correct ordering of the # groups. # see more examples in test_ProximalTree.m of valid tree-structured sets of groups. # # The first fields sets the weights for every group # tree['eta_g'] double N vector # # The next field sets inclusion relations between groups # (but not between groups and variables): # tree['groups'] sparse (double or boolean) N x N matrix # the (i,j) entry is non-zero if and only if i is different than j and # gi is included in gj. # the first column corresponds to the group at the root of the tree. # # The next field define the smallest index of each group gi, # which is also the smallest index of root(gi) # tree['own_variables'] int32 N vector # # The next field define for each group gi, the size of root(gi) # tree['N_own_variables'] int32 N vector # # examples are given in test_ProximalTree.m # # return_val_loss: # if true the function will return a tuple of matrices. # lambda1: (regularization parameter) # regul: (choice of regularization, see above) # lambda2: (optional, regularization parameter) # lambda3: (optional, regularization parameter) # verbose: (optional, verbosity level, false by default) # intercept: (optional, last row of U is not regularized, # false by default) # pos: (optional, adds positivity constraints on the # coefficients, false by default) # transpose: (optional, transpose the matrix in the regularization function) # size_group: (optional, for regularization functions assuming a group # structure). It is a scalar. When groups is not specified, it assumes # that the groups are the sets of consecutive elements of size size_group # numThreads: (optional, number of threads for exploiting # multi-core / multi-cpus. By default, it takes the value -1, # which automatically selects all the available CPUs/cores). # resetflow: undocumented; modify at your own risks! # clever: undocumented; modify at your own risks! # # Output: # V: double m x n matrix (output coefficients) # val_regularizer: double 1 x n vector (value of the regularization # term at the optimum). # val_loss: vector of size U.shape[1] # alpha = spams.proximalTree(U,tree,return_val_loss = False,...) # (alpha,val_loss) = spams.proximalTree(U,tree,return_val_loss = True,...) # # Authors: # Julien MAIRAL, 2010 (spams, matlab interface and documentation) # Jean-Paul CHIEZE 2011-2012 (python interface) # # Note: # Valid values for the regularization parameter (regul) are: # "l0", "l1", "l2", "linf", "l2-not-squared", "elastic-net", "fused-lasso", # "group-lasso-l2", "group-lasso-linf", "sparse-group-lasso-l2", # "sparse-group-lasso-linf", "l1l2", "l1linf", "l1l2+l1", "l1linf+l1", # "tree-l0", "tree-l2", "tree-linf", "graph", "graph-ridge", "graph-l2", # "multi-task-tree", "multi-task-graph", "l1linf-row-column", "trace-norm", # "trace-norm-vec", "rank", "rank-vec", "none" # | 
The following piece of code illustrates how to use this function. The following piece of code contains usage examples:
| import spams import numpy as np param = {'numThreads' : -1,'verbose' : True, 'pos' : False, 'intercept' : False, 'lambda1' : 0.1 } m = 10;n = 1000 U = np.asfortranarray(np.random.normal(size = (m,n)),dtype=myfloat) print 'First tree example' # Example 1 of tree structure # tree structured groups: # g1= {0 1 2 3 4 5 6 7 8 9} # g2= {2 3 4} # g3= {5 6 7 8 9} own_variables = np.array([0,2,5],dtype=np.int32) # pointer to the first variable of each group N_own_variables = np.array([2,3,5],dtype=np.int32) # number of "root" variables in each group # (variables that are in a group, but not in its descendants). # for instance root(g1)={0,1}, root(g2)={2 3 4}, root(g3)={5 6 7 8 9} eta_g = np.array([1,1,1],dtype=myfloat) # weights for each group, they should be non-zero to use fenchel duality groups = np.asfortranarray([[0,0,0], [1,0,0], [1,0,0]],dtype = np.bool) # first group should always be the root of the tree # non-zero entriees mean inclusion relation ship, here g2 is a children of g1, # g3 is a children of g1 groups = ssp.csc_matrix(groups,dtype=np.bool) tree = {'eta_g': eta_g,'groups' : groups,'own_variables' : own_variables, 'N_own_variables' : N_own_variables} print '\ntest prox tree-l0' param['regul'] = 'tree-l2' alpha = spams.proximalTree(U,tree,False,**param) print '\ntest prox tree-linf' param['regul'] = 'tree-linf' alpha = spams.proximalTree(U,tree,False,**param) print 'Second tree example' # Example 2 of tree structure # tree structured groups: # g1= {0 1 2 3 4 5 6 7 8 9} root(g1) = { }; # g2= {0 1 2 3 4 5} root(g2) = {0 1 2}; # g3= {3 4} root(g3) = {3 4}; # g4= {5} root(g4) = {5}; # g5= {6 7 8 9} root(g5) = { }; # g6= {6 7} root(g6) = {6 7}; # g7= {8 9} root(g7) = {8}; # g8 = {9} root(g8) = {9}; own_variables = np.array([0, 0, 3, 5, 6, 6, 8, 9],dtype=np.int32) N_own_variables = np.array([0,3,2,1,0,2,1,1],dtype=np.int32) eta_g = np.array([1,1,1,2,2,2,2.5,2.5],dtype=myfloat) groups = np.asfortranarray([[0,0,0,0,0,0,0,0], [1,0,0,0,0,0,0,0], [0,1,0,0,0,0,0,0], [0,1,0,0,0,0,0,0], [1,0,0,0,0,0,0,0], [0,0,0,0,1,0,0,0], [0,0,0,0,1,0,0,0], [0,0,0,0,0,0,1,0]],dtype = np.bool) groups = ssp.csc_matrix(groups,dtype=np.bool) tree = {'eta_g': eta_g,'groups' : groups, 'own_variables' : own_variables, 'N_own_variables' : N_own_variables} print '\ntest prox tree-l0' param['regul'] = 'tree-l0' alpha = spams.proximalTree(U,tree,False,**param) print '\ntest prox tree-l2' param['regul'] = 'tree-l2' alpha = spams.proximalTree(U,tree,False,**param) print '\ntest prox tree-linf' param['regul'] = 'tree-linf' alpha = spams.proximalTree(U,tree,False,**param) # mexProximalTree also works with non-tree-structured regularization functions print '\nprox l1, intercept, positivity constraint' param['regul'] = 'l1' param['pos'] = True # can be used with all the other regularizations param['intercept'] = True # can be used with all the other regularizations alpha = spams.proximalTree(U,tree,False,**param) print '\nprox multi-task tree' param['pos'] = False param['intercept'] = False param['lambda2'] = param['lambda1'] param['regul'] = 'multi-task-tree' alpha = spams.proximalTree(U,tree,False,**param) | 
This function computes the proximal operators associated to structured sparse regularization, for input signals U=[u1,…,un] in ℝp × n, and a set of groups [22], it returns a matrix V=[v1,…,vn] in ℝp × n. When one uses a regularization function on vectors, it computes a column v of V for every column u of U:
| 
 | 
 | ||u−v||22 + λ | 
 | ηg ||vg||∞, (44) | 
or with a regularization function on matrices, it computes V solving
| 
 | 
 | ||U−V||F2 + λ | 
 | 
 | ηg ||vgi||∞+ λ2 | 
 | 
 | ||vgj||∞, (45) | 
This function can also be used for computing the proximal operators addressed by spams.proximalFlat. The way the graph is incoded is presented below (and also in the example file test_ProximalGraph.m, with more usage details:
| # # Name: proximalGraph # # Usage: spams.proximalGraph(U,graph,return_val_loss = False,numThreads =-1,lambda1=1.0,lambda2=0., # lambda3=0.,intercept=False,resetflow=False,regul="",verbose=False, # pos=False,clever=True,eval= None,size_group=1,transpose=False) # # Description: # proximalGraph computes a proximal operator. Depending # on the value of regul, it computes # # Given an input matrix U=[u^1,\ldots,u^n], and a set of groups G, # it computes a matrix V=[v^1,\ldots,v^n] such that # # if regul='graph' # for every column u of U, it computes a column v of V solving # argmin 0.5||u-v||_2^2 + lambda1\sum_{g \in G} \eta_g||v_g||_inf # # if regul='graph+ridge' # for every column u of U, it computes a column v of V solving # argmin 0.5||u-v||_2^2 + lambda1\sum_{g \in G} \eta_g||v_g||_inf + lambda1_2||v||_2^2 # # # if regul='multi-task-graph' # V=argmin 0.5||U-V||_F^2 + lambda1 \sum_{i=1}^n\sum_{g \in G} \eta_g||v^i_g||_inf + ... # lambda1_2 \sum_{g \in G} \eta_g max_{j in g}||V_j||_{inf} # # it can also be used with any regularization addressed by proximalFlat # # for all these regularizations, it is possible to enforce non-negativity constraints # with the option pos, and to prevent the last row of U to be regularized, with # the option intercept # # Inputs: # U: double p x n matrix (input signals) # m is the signal size # graph: struct # with three fields, eta_g, groups, and groups_var # # The first fields sets the weights for every group # graph.eta_g double N vector # # The next field sets inclusion relations between groups # (but not between groups and variables): # graph.groups sparse (double or boolean) N x N matrix # the (i,j) entry is non-zero if and only if i is different than j and # gi is included in gj. # # The next field sets inclusion relations between groups and variables # graph.groups_var sparse (double or boolean) p x N matrix # the (i,j) entry is non-zero if and only if the variable i is included # in gj, but not in any children of gj. # # examples are given in test_ProximalGraph.m # # return_val_loss: # if true the function will return a tuple of matrices. # lambda1: (regularization parameter) # regul: (choice of regularization, see above) # lambda2: (optional, regularization parameter) # lambda3: (optional, regularization parameter) # verbose: (optional, verbosity level, false by default) # intercept: (optional, last row of U is not regularized, # false by default) # pos: (optional, adds positivity constraints on the # coefficients, false by default) # numThreads: (optional, number of threads for exploiting # multi-core / multi-cpus. By default, it takes the value -1, # which automatically selects all the available CPUs/cores). # resetflow: undocumented; modify at your own risks! # clever: undocumented; modify at your own risks! # size_group: undocumented; modify at your own risks! # transpose: undocumented; modify at your own risks! # # Output: # V: double p x n matrix (output coefficients) # val_regularizer: double 1 x n vector (value of the regularization # term at the optimum). # val_loss: vector of size U.shape[1] # alpha = spams.proximalGraph(U,graph,return_val_loss = False,...) # (alpha,val_loss) = spams.proximalGraph(U,graph,return_val_loss = True,...) # # Authors: # Julien MAIRAL, 2010 (spams, matlab interface and documentation) # Jean-Paul CHIEZE 2011-2012 (python interface) # # Note: # Valid values for the regularization parameter (regul) are: # "l0", "l1", "l2", "linf", "l2-not-squared", "elastic-net", "fused-lasso", # "group-lasso-l2", "group-lasso-linf", "sparse-group-lasso-l2", # "sparse-group-lasso-linf", "l1l2", "l1linf", "l1l2+l1", "l1linf+l1", # "tree-l0", "tree-l2", "tree-linf", "graph", "graph-ridge", "graph-l2", # "multi-task-tree", "multi-task-graph", "l1linf-row-column", "trace-norm", # "trace-norm-vec", "rank", "rank-vec", "none" # | 
The following piece of code illustrates how to use this function. The following piece of code contains usage examples:
| import spams import numpy as np np.random.seed(0) lambda1 = 0.1 # regularization parameter num_threads = -1 # all cores (-1 by default) verbose = True # verbosity, false by default pos = False # can be used with all the other regularizations intercept = False # can be used with all the other regularizations U = np.asfortranarray(np.random.normal(size = (10,100)),dtype=myfloat) print 'First graph example' # Example 1 of graph structure # groups: # g1= {0 1 2 3} # g2= {3 4 5 6} # g3= {6 7 8 9} eta_g = np.array([1, 1, 1],dtype=myfloat) groups = ssp.csc_matrix(np.zeros((3,3)),dtype = np.bool) groups_var = ssp.csc_matrix( np.array([[1, 0, 0], [1, 0, 0], [1, 0, 0], [1, 1, 0], [0, 1, 0], [0, 1, 0], [0, 1, 1], [0, 0, 1], [0, 0, 1], [0, 0, 1]],dtype=np.bool),dtype=np.bool) graph = {'eta_g': eta_g,'groups' : groups,'groups_var' : groups_var} print '\ntest prox graph' regul='graph' alpha = spams.proximalGraph(U,graph,False,lambda1 = lambda1,numThreads = num_threads ,verbose = verbose,pos = pos,intercept = intercept,regul = regul) # Example 2 of graph structure # groups: # g1= {0 1 2 3} # g2= {3 4 5 6} # g3= {6 7 8 9} # g4= {0 1 2 3 4 5} # g5= {6 7 8} eta_g = np.array([1, 1, 1, 1, 1],dtype=myfloat) groups = ssp.csc_matrix( np.array([[0, 0, 0, 1, 0], [0, 0, 0, 0, 0], [0, 0, 0, 0, 0], [0, 0, 0, 0, 0], [0, 0, 1, 0, 0]],dtype=np.bool),dtype=np.bool) groups_var = ssp.csc_matrix( np.array([[1, 0, 0, 0, 0], [1, 0, 0, 0, 0], [1, 0, 0, 0, 0], [1, 1, 0, 0, 0], [0, 1, 0, 1, 0], [0, 1, 0, 1, 0], [0, 1, 0, 0, 1], [0, 0, 0, 0, 1], [0, 0, 0, 0, 1], [0, 0, 1, 0, 0]],dtype=np.bool),dtype=np.bool) graph = {'eta_g': eta_g,'groups' : groups,'groups_var' : groups_var} print '\ntest prox graph' alpha = spams.proximalGraph(U,graph,False,lambda1 = lambda1,numThreads = num_threads ,verbose = verbose,pos = pos,intercept = intercept,regul = regul) # print '\ntest prox multi-task-graph' regul = 'multi-task-graph' lambda2 = 0.1 alpha = spams.proximalGraph(U,graph,False,lambda1 = lambda1,lambda2 = lambda2,numThreads = num_threads ,verbose = verbose,pos = pos,intercept = intercept,regul = regul) # print '\ntest no regularization' regul = 'none' alpha = spams.proximalGraph(U,graph,False,lambda1 = lambda1,lambda2 = lambda2,numThreads = num_threads ,verbose = verbose,pos = pos,intercept = intercept,regul = regul) | 
This function computes the proximal operators associated to the path coding penalties of [24].
| # # The python function is not yet implemented. # | 
The following piece of code illustrates how to use this function. This function is associated to a function to evaluate the penalties:
| # # The python function is not yet implemented. # | 
The following piece of code illustrates how to use this function.
After having presented the regularization terms which our software can handle, we present the various formulations that we address
We present here regression or classification formulations and their multi-task variants.
Given a training set {xi,yi}i=1n, with xi ∈ ℝp and yi ∈ ℝ for all i in [ 1;n ], we address
| 
 | 
 | 
 | (yi−w⊤xi−b)2 + λψ(w), | 
where b is an optional variable acting as an “intercept”, which is not regularized, and ψ can be any of the regularization functions presented above. Let us consider the vector y in ℝn that carries the entries yi. The problem without the intercept takes the following form, which we have already encountered in the previous toolbox, but with different notations:
| 
 | 
 | ||y−Xw||22 + λψ(w), | 
where the X=[xi,…,xn]T (the xi’s are here the rows of X).
The next formulation that our software can solve is the regularized logistic regression formulation. We are again given a training set {xi,yi}i=1n, with xi ∈ ℝp, but the variables yi are now in {−1,+1} for all i in [ 1;n ]. The optimization problem we address is
| 
 | 
 | 
 | log(1+e−yi(w⊤xi+b) + λψ(w), | 
with again ψ taken to be one of the regularization function presented above, and b is an optional intercept.
We have also implemented a multi-class logistic classifier (or softmax). For a classification problem with r classes, we are given a training set {xi,yi}i=1n, where the variables xi are still vectors in ℝp, but the yi’s have integer values in {1,2,…,r}. The formulation we address is the following multi-class learning problem
| 
 | 
 | 
 | log | ⎛ ⎜ ⎝ | 
 | e (wj−wyi)⊤xi + bj−byi | ⎞ ⎟ ⎠ | + λ | 
 | ψ(wj), (46) | 
where W = [w1,…,wr] and the optional vector b in ℝr carries intercepts for each class.
We are now considering a problem with r tasks, and a training set {xi,yi}i=1n, where the variables xi are still vectors in ℝp, and yi is a vector in ℝr. We are looking for r regression vectors wj, for j∈ [ 1;r ], or equivalently for a matrix W=[w1,…,wr] in ℝp × r. The formulation we address is the following multi-task regression problem
| 
 | 
 | 
 | 
 | (yji−w⊤xi−bj)2 + λψ(W), | 
where ψ is any of the regularization function on matrices we have presented in the previous section. Note that by introducing the appropriate variables Y, the problem without intercept could be equivalently rewritten
| 
 | 
 | ||Y−XW||F2 + λψ(W). | 
The multi-task version of the logistic regression follows the same principle. We consider r tasks, and a training set {xi,yi}i=1n, with the xi’s in ℝp, and the yi’s are vectors in {−1,+1}r. We look for a matrix W=[w1,…,wr] in ℝp × r. The formulation is the following multi-task regression problem
| 
 | 
 | 
 | 
 | log | ⎛ ⎜ ⎝ | 1+e−yji(w⊤xi+bj) | ⎞ ⎟ ⎠ | + λψ(W). | 
The multi-task/multi-class version directly follows from the formulation of Eq. (46), but associates with each class a task, and as a consequence, regularizes the matrix W in a particular way:
| 
 | 
 | 
 | log | ⎛ ⎜ ⎝ | 
 | e (wj−wyi)⊤xi + bj−byi | ⎞ ⎟ ⎠ | + λψ(W). | 
How duality gaps are computed for any of these formulations is presented in Appendix A. We now present the main functions for solving these problems
Given a matrix X=[x1,…,xp]T in ℝm × p, and a matrix Y=[y1,…,yn], it solves the optimization problems presented in the previous section, with the same regularization functions as spams.proximalFlat. see usage details below:
| # # Name: fistaFlat # # Usage: spams.fistaFlat(Y,X,W0,return_optim_info = False,numThreads =-1,max_it =1000,L0=1.0, # fixed_step=False,gamma=1.5,lambda1=1.0,delta=1.0,lambda2=0.,lambda3=0., # a=1.0,b=0.,c=1.0,tol=0.000001,it0=100,max_iter_backtracking=1000, # compute_gram=False,lin_admm=False,admm=False,intercept=False, # resetflow=False,regul="",loss="",verbose=False,pos=False,clever=False, # log=False,ista=False,subgrad=False,logName="",is_inner_weights=False, # inner_weights=None,size_group=1,groups = None,sqrt_step=True, # transpose=False,linesearch_mode=0) # # Description: # fistaFlat solves sparse regularized problems. # X is a design matrix of size m x p # X=[x^1,...,x^n]', where the x_i's are the rows of X # Y=[y^1,...,y^n] is a matrix of size m x n # It implements the algorithms FISTA, ISTA and subgradient descent. # # - if loss='square' and regul is a regularization function for vectors, # the entries of Y are real-valued, W = [w^1,...,w^n] is a matrix of size p x n # For all column y of Y, it computes a column w of W such that # w = argmin 0.5||y- X w||_2^2 + lambda1 psi(w) # # - if loss='square' and regul is a regularization function for matrices # the entries of Y are real-valued, W is a matrix of size p x n. # It computes the matrix W such that # W = argmin 0.5||Y- X W||_F^2 + lambda1 psi(W) # # - loss='square-missing' same as loss='square', but handles missing data # represented by NaN (not a number) in the matrix Y # # - if loss='logistic' and regul is a regularization function for vectors, # the entries of Y are either -1 or +1, W = [w^1,...,w^n] is a matrix of size p x n # For all column y of Y, it computes a column w of W such that # w = argmin (1/m)sum_{j=1}^m log(1+e^(-y_j x^j' w)) + lambda1 psi(w), # where x^j is the j-th row of X. # # - if loss='logistic' and regul is a regularization function for matrices # the entries of Y are either -1 or +1, W is a matrix of size p x n # W = argmin sum_{i=1}^n(1/m)sum_{j=1}^m log(1+e^(-y^i_j x^j' w^i)) + lambda1 psi(W) # # - if loss='multi-logistic' and regul is a regularization function for vectors, # the entries of Y are in {0,1,...,N} where N is the total number of classes # W = [W^1,...,W^n] is a matrix of size p x Nn, each submatrix W^i is of size p x N # for all submatrix WW of W, and column y of Y, it computes # WW = argmin (1/m)sum_{j=1}^m log(sum_{j=1}^r e^(x^j'(ww^j-ww^{y_j}))) + lambda1 sum_{j=1}^N psi(ww^j), # where ww^j is the j-th column of WW. # # - if loss='multi-logistic' and regul is a regularization function for matrices, # the entries of Y are in {0,1,...,N} where N is the total number of classes # W is a matrix of size p x N, it computes # W = argmin (1/m)sum_{j=1}^m log(sum_{j=1}^r e^(x^j'(w^j-w^{y_j}))) + lambda1 psi(W) # where ww^j is the j-th column of WW. # # - loss='cur' useful to perform sparse CUR matrix decompositions, # W = argmin 0.5||Y-X*W*X||_F^2 + lambda1 psi(W) # # # The function psi are those used by proximalFlat (see documentation) # # This function can also handle intercepts (last row of W is not regularized), # and/or non-negativity constraints on W, and sparse matrices for X # # Inputs: # Y: double dense m x n matrix # X: double dense or sparse m x p matrix # W0: double dense p x n matrix or p x Nn matrix (for multi-logistic loss) # initial guess # return_optim_info: # if true the function will return a tuple of matrices. # loss: (choice of loss, see above) # regul: (choice of regularization, see function proximalFlat) # lambda1: (regularization parameter) # lambda2: (optional, regularization parameter, 0 by default) # lambda3: (optional, regularization parameter, 0 by default) # verbose: (optional, verbosity level, false by default) # pos: (optional, adds positivity constraints on the # coefficients, false by default) # transpose: (optional, transpose the matrix in the regularization function) # size_group: (optional, for regularization functions assuming a group # structure) # groups: (int32, optional, for regularization functions assuming a group # structure, see proximalFlat) # numThreads: (optional, number of threads for exploiting # multi-core / multi-cpus. By default, it takes the value -1, # which automatically selects all the available CPUs/cores). # max_it: (optional, maximum number of iterations, 100 by default) # it0: (optional, frequency for computing duality gap, every 10 iterations by default) # tol: (optional, tolerance for stopping criteration, which is a relative duality gap # if it is available, or a relative change of parameters). # gamma: (optional, multiplier for increasing the parameter L in fista, 1.5 by default) # L0: (optional, initial parameter L in fista, 0.1 by default, should be small enough) # fixed_step: (deactive the line search for L in fista and use L0 instead) # linesearch_mode: (line-search scheme when ista=true: # 0: default, monotonic backtracking scheme # 1: monotonic backtracking scheme, with restart at each iteration # 2: Barzilai-Borwein step sizes (similar to SparSA by Wright et al.) # 3: non-monotonic backtracking # compute_gram: (optional, pre-compute X^TX, false by default). # intercept: (optional, do not regularize last row of W, false by default). # ista: (optional, use ista instead of fista, false by default). # subgrad: (optional, if not ista, use subradient descent instead of fista, false by default). # a: # b: (optional, if subgrad, the gradient step is a/(t+b) # also similar options as proximalFlat # # the function also implements the ADMM algorithm via an option admm=true. It is not documented # and you need to look at the source code to use it. # delta: undocumented; modify at your own risks! # c: undocumented; modify at your own risks! # max_iter_backtracking: undocumented; modify at your own risks! # lin_admm: undocumented; modify at your own risks! # admm: undocumented; modify at your own risks! # resetflow: undocumented; modify at your own risks! # clever: undocumented; modify at your own risks! # log: undocumented; modify at your own risks! # logName: undocumented; modify at your own risks! # is_inner_weights: undocumented; modify at your own risks! # inner_weights: undocumented; modify at your own risks! # sqrt_step: undocumented; modify at your own risks! # # Output: # W: double dense p x n matrix or p x Nn matrix (for multi-logistic loss) # optim: optional, double dense 4 x n matrix. # first row: values of the objective functions. # third row: values of the relative duality gap (if available) # fourth row: number of iterations # optim_info: vector of size 4, containing information of the optimization. # W = spams.fistaFlat(Y,X,W0,return_optim_info = False,...) # (W,optim_info) = spams.fistaFlat(Y,X,W0,return_optim_info = True,...) # # Authors: # Julien MAIRAL, 2010 (spams, matlab interface and documentation) # Jean-Paul CHIEZE 2011-2012 (python interface) # # Note: # Valid values for the regularization parameter (regul) are: # "l0", "l1", "l2", "linf", "l2-not-squared", "elastic-net", "fused-lasso", # "group-lasso-l2", "group-lasso-linf", "sparse-group-lasso-l2", # "sparse-group-lasso-linf", "l1l2", "l1linf", "l1l2+l1", "l1linf+l1", # "tree-l0", "tree-l2", "tree-linf", "graph", "graph-ridge", "graph-l2", # "multi-task-tree", "multi-task-graph", "l1linf-row-column", "trace-norm", # "trace-norm-vec", "rank", "rank-vec", "none" # | 
The following piece of code illustrates how to use this function. The following piece of code contains usage examples:
| import spams import numpy as np param = {'numThreads' : -1,'verbose' : True, 'lambda1' : 0.05, 'it0' : 10, 'max_it' : 200, 'L0' : 0.1, 'tol' : 1e-3, 'intercept' : False, 'pos' : False} np.random.seed(0) m = 100;n = 200 X = np.asfortranarray(np.random.normal(size = (m,n))) X = np.asfortranarray(X - np.tile(np.mean(X,0),(X.shape[0],1)),dtype=myfloat) X = spams.normalize(X) Y = np.asfortranarray(np.random.normal(size = (m,1))) Y = np.asfortranarray(Y - np.tile(np.mean(Y,0),(Y.shape[0],1)),dtype=myfloat) Y = spams.normalize(Y) W0 = np.zeros((X.shape[1],Y.shape[1]),dtype=myfloat,order="FORTRAN") # Regression experiments # 100 regression problems with the same design matrix X. print '\nVarious regression experiments' param['compute_gram'] = True print '\nFISTA + Regression l1' param['loss'] = 'square' param['regul'] = 'l1' # param.regul='group-lasso-l2'; # param.size_group=10; (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) ## print "XX %s" %str(optim_info.shape);return None print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[2,:],0),np.mean(optim_info[3,:],0)) ### print '\nISTA + Regression l1' param['ista'] = True (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f\n' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) ## print '\nSubgradient Descent + Regression l1' param['ista'] = False param['subgrad'] = True param['a'] = 0.1 param['b'] = 1000 # arbitrary parameters max_it = param['max_it'] it0 = param['it0'] param['max_it'] = 500 param['it0'] = 50 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f\n' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) param['subgrad'] = False param['max_it'] = max_it param['it0'] = it0 ### print '\nFISTA + Regression l2' param['regul'] = 'l2' (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f\n' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) ### print '\nFISTA + Regression l2 + sparse feature matrix' param['regul'] = 'l2'; (W, optim_info) = spams.fistaFlat(Y,ssp.csc_matrix(X),W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) ########### print '\nFISTA + Regression Elastic-Net' param['regul'] = 'elastic-net' param['lambda2'] = 0.1 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[3,:])) print '\nFISTA + Group Lasso L2' param['regul'] = 'group-lasso-l2' param['size_group'] = 2 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[2,:],0),np.mean(optim_info[3,:],0)) print '\nFISTA + Group Lasso L2 with variable size of groups' param['regul'] = 'group-lasso-l2' param2=param.copy() param2['groups'] = np.array(np.random.random_integers(1,5,X.shape[1]),dtype = np.int32) param2['lambda1'] *= 10 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[2,:],0),np.mean(optim_info[3,:],0)) print '\nFISTA + Trace Norm' param['regul'] = 'trace-norm-vec' param['size_group'] = 5 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:],0),np.mean(optim_info[3,:])) #### print '\nFISTA + Regression Fused-Lasso' param['regul'] = 'fused-lasso' param['lambda2'] = 0.1 param['lambda3'] = 0.1; # (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[3,:])) print '\nFISTA + Regression no regularization' param['regul'] = 'none' (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[3,:])) print '\nFISTA + Regression l1 with intercept ' param['intercept'] = True param['regul'] = 'l1' x1 = np.asfortranarray(np.concatenate((X,np.ones((X.shape[0],1))),1),dtype=myfloat) W01 = np.asfortranarray(np.concatenate((W0,np.zeros((1,W0.shape[1]))),0),dtype=myfloat) (W, optim_info) = spams.fistaFlat(Y,x1,W01,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) print '\nFISTA + Regression l1 with intercept+ non-negative ' param['pos'] = True param['regul'] = 'l1' x1 = np.asfortranarray(np.concatenate((X,np.ones((X.shape[0],1))),1),dtype=myfloat) W01 = np.asfortranarray(np.concatenate((W0,np.zeros((1,W0.shape[1]))),0),dtype=myfloat) (W, optim_info) = spams.fistaFlat(Y,x1,W01,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[3,:])) param['pos'] = False param['intercept'] = False print '\nISTA + Regression l0' param['regul'] = 'l0' (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[3,:])) # Classification print '\nOne classification experiment' Y = np.asfortranarray(2 * np.asarray(np.random.normal(size = (100,1)) > 0,dtype=myfloat) - 1) print '\nFISTA + Logistic l1' param['regul'] = 'l1' param['loss'] = 'logistic' param['lambda1'] = 0.01 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) # can be used of course with other regularization functions, intercept,... param['regul'] = 'l1' param['loss'] = 'weighted-logistic' param['lambda1'] = 0.01 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) # can be used of course with other regularization functions, intercept,... print '\nFISTA + Logistic l1 + sparse matrix' param['loss'] = 'logistic' (W, optim_info) = spams.fistaFlat(Y,ssp.csc_matrix(X),W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) # can be used of course with other regularization functions, intercept,... # Multi-Class classification Y = np.asfortranarray(np.ceil(5 * np.random.random(size = (100,1000))) - 1,dtype=myfloat) param['loss'] = 'multi-logistic' print '\nFISTA + Multi-Class Logistic l1' nclasses = np.max(Y[:])+1 W0 = np.zeros((X.shape[1],nclasses * Y.shape[1]),dtype=myfloat,order="FORTRAN") (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) # can be used of course with other regularization functions, intercept,... # Multi-Task regression Y = np.asfortranarray(np.random.normal(size = (100,100)),dtype=myfloat) Y = np.asfortranarray(Y - np.tile(np.mean(Y,0),(Y.shape[0],1)),dtype=myfloat) Y = spams.normalize(Y) param['compute_gram'] = False W0 = np.zeros((X.shape[1],Y.shape[1]),dtype=myfloat,order="FORTRAN") param['loss'] = 'square' print '\nFISTA + Regression l1l2 ' param['regul'] = 'l1l2' (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) print '\nFISTA + Regression l1linf ' param['regul'] = 'l1linf' (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) print '\nFISTA + Regression l1l2 + l1 ' param['regul'] = 'l1l2+l1' param['lambda2'] = 0.1 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[3,:])) print '\nFISTA + Regression l1linf + l1 ' param['regul'] = 'l1linf+l1' param['lambda2'] = 0.1 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[3,:])) print '\nFISTA + Regression l1linf + row + columns ' param['regul'] = 'l1linf-row-column' param['lambda2'] = 0.1 (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) # Multi-Task Classification print '\nFISTA + Logistic + l1l2 ' param['regul'] = 'l1l2' param['loss'] = 'logistic' Y = np.asfortranarray(2 * np.asarray(np.random.normal(size = (100,100)) > 1,dtype=myfloat) - 1) (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) # Multi-Class + Multi-Task Regularization print '\nFISTA + Multi-Class Logistic l1l2 ' Y = np.asfortranarray(np.ceil(5 * np.random.random(size = (100,1000))) - 1,dtype=myfloat) Y = spams.normalize(Y) param['loss'] = 'multi-logistic' param['regul'] = 'l1l2' nclasses = np.max(Y[:])+1 W0 = np.zeros((X.shape[1],nclasses * Y.shape[1]),dtype=myfloat,order="FORTRAN") (W, optim_info) = spams.fistaFlat(Y,X,W0,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),np.mean(optim_info[3,:])) # can be used of course with other regularization functions, intercept,... ############# | 
Given a matrix X=[x1,…,xp]T in ℝm × p, and a matrix Y=[y1,…,yn], it solves the optimization problems presented in the previous section, with the same regularization functions as spams.proximalTree. see usage details below:
| # # Name: fistaTree # # Usage: spams.fistaTree(Y,X,W0,tree,return_optim_info = False,numThreads =-1,max_it =1000,L0=1.0, # fixed_step=False,gamma=1.5,lambda1=1.0,delta=1.0,lambda2=0.,lambda3=0., # a=1.0,b=0.,c=1.0,tol=0.000001,it0=100,max_iter_backtracking=1000, # compute_gram=False,lin_admm=False,admm=False,intercept=False, # resetflow=False,regul="",loss="",verbose=False,pos=False,clever=False, # log=False,ista=False,subgrad=False,logName="",is_inner_weights=False, # inner_weights=None,size_group=1,sqrt_step=True,transpose=False, # linesearch_mode=0) # # Description: # fistaTree solves sparse regularized problems. # X is a design matrix of size m x p # X=[x^1,...,x^n]', where the x_i's are the rows of X # Y=[y^1,...,y^n] is a matrix of size m x n # It implements the algorithms FISTA, ISTA and subgradient descent for solving # # min_W loss(W) + lambda1 psi(W) # # The function psi are those used by proximalTree (see documentation) # for the loss functions, see the documentation of fistaFlat # # This function can also handle intercepts (last row of W is not regularized), # and/or non-negativity constraints on W and sparse matrices X # # Inputs: # Y: double dense m x n matrix # X: double dense or sparse m x p matrix # W0: double dense p x n matrix or p x Nn matrix (for multi-logistic loss) # initial guess # tree: named list (see documentation of proximalTree) # return_optim_info: # if true the function will return a tuple of matrices. # loss: (choice of loss, see above) # regul: (choice of regularization, see function proximalFlat) # lambda1: (regularization parameter) # lambda2: (optional, regularization parameter, 0 by default) # lambda3: (optional, regularization parameter, 0 by default) # verbose: (optional, verbosity level, false by default) # pos: (optional, adds positivity constraints on the # coefficients, false by default) # transpose: (optional, transpose the matrix in the regularization function) # size_group: (optional, for regularization functions assuming a group # structure) # numThreads: (optional, number of threads for exploiting # multi-core / multi-cpus. By default, it takes the value -1, # which automatically selects all the available CPUs/cores). # max_it: (optional, maximum number of iterations, 100 by default) # it0: (optional, frequency for computing duality gap, every 10 iterations by default) # tol: (optional, tolerance for stopping criteration, which is a relative duality gap # if it is available, or a relative change of parameters). # gamma: (optional, multiplier for increasing the parameter L in fista, 1.5 by default) # L0: (optional, initial parameter L in fista, 0.1 by default, should be small enough) # fixed_step: (deactive the line search for L in fista and use L0 instead) # compute_gram: (optional, pre-compute X^TX, false by default). # intercept: (optional, do not regularize last row of W, false by default). # ista: (optional, use ista instead of fista, false by default). # subgrad: (optional, if not ista, use subradient descent instead of fista, false by default). # a: # b: (optional, if subgrad, the gradient step is a/(t+b) # also similar options as proximalTree # # the function also implements the ADMM algorithm via an option admm=true. It is not documented # and you need to look at the source code to use it. # delta: undocumented; modify at your own risks! # c: undocumented; modify at your own risks! # max_iter_backtracking: undocumented; modify at your own risks! # lin_admm: undocumented; modify at your own risks! # admm: undocumented; modify at your own risks! # resetflow: undocumented; modify at your own risks! # clever: undocumented; modify at your own risks! # log: undocumented; modify at your own risks! # logName: undocumented; modify at your own risks! # is_inner_weights: undocumented; modify at your own risks! # inner_weights: undocumented; modify at your own risks! # sqrt_step: undocumented; modify at your own risks! # # Output: # W: double dense p x n matrix or p x Nn matrix (for multi-logistic loss) # optim: optional, double dense 4 x n matrix. # first row: values of the objective functions. # third row: values of the relative duality gap (if available) # fourth row: number of iterations # optim_info: vector of size 4, containing information of the optimization. # W = spams.fistaTree(Y,X,W0,tree,return_optim_info = False,...) # (W,optim_info) = spams.fistaTree(Y,X,W0,tree,return_optim_info = True,...) # # Authors: # Julien MAIRAL, 2010 (spams, matlab interface and documentation) # Jean-Paul CHIEZE 2011-2012 (python interface) # # Note: # Valid values for the regularization parameter (regul) are: # "l0", "l1", "l2", "linf", "l2-not-squared", "elastic-net", "fused-lasso", # "group-lasso-l2", "group-lasso-linf", "sparse-group-lasso-l2", # "sparse-group-lasso-linf", "l1l2", "l1linf", "l1l2+l1", "l1linf+l1", # "tree-l0", "tree-l2", "tree-linf", "graph", "graph-ridge", "graph-l2", # "multi-task-tree", "multi-task-graph", "l1linf-row-column", "trace-norm", # "trace-norm-vec", "rank", "rank-vec", "none" # | 
The following piece of code illustrates how to use this function. The following piece of code contains usage examples:
| import spams import numpy as np param = {'numThreads' : -1,'verbose' : False, 'lambda1' : 0.001, 'it0' : 10, 'max_it' : 200, 'L0' : 0.1, 'tol' : 1e-5, 'intercept' : False, 'pos' : False} np.random.seed(0) m = 100;n = 10 X = np.asfortranarray(np.random.normal(size = (m,n))) X = np.asfortranarray(X - np.tile(np.mean(X,0),(X.shape[0],1)),dtype=myfloat) X = spams.normalize(X) Y = np.asfortranarray(np.random.normal(size = (m,m))) Y = np.asfortranarray(Y - np.tile(np.mean(Y,0),(Y.shape[0],1)),dtype=myfloat) Y = spams.normalize(Y) W0 = np.zeros((X.shape[1],Y.shape[1]),dtype=myfloat,order="FORTRAN") own_variables = np.array([0,0,3,5,6,6,8,9],dtype=np.int32) N_own_variables = np.array([0,3,2,1,0,2,1,1],dtype=np.int32) eta_g = np.array([1,1,1,2,2,2,2.5,2.5],dtype=myfloat) groups = np.asfortranarray([[0, 0, 0, 0, 0, 0, 0, 0], [1, 0, 0, 0, 0, 0, 0, 0], [0, 1, 0, 0, 0, 0, 0, 0], [0, 1, 0, 0, 0, 0, 0, 0], [1, 0, 0, 0, 0, 0, 0, 0], [0, 0, 0, 0, 1, 0, 0, 0], [0, 0, 0, 0, 1, 0, 0, 0], [0, 0, 0, 0, 0, 0, 1, 0]],dtype = np.bool) groups = ssp.csc_matrix(groups,dtype=np.bool) tree = {'eta_g': eta_g,'groups' : groups,'own_variables' : own_variables, 'N_own_variables' : N_own_variables} print '\nVarious regression experiments' param['compute_gram'] = True print '\nFISTA + Regression tree-l2' param['loss'] = 'square' param['regul'] = 'tree-l2' (W, optim_info) = spams.fistaTree(Y,X,W0,tree,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[3,:],0)) ### print '\nFISTA + Regression tree-linf' param['regul'] = 'tree-linf' (W, optim_info) = spams.fistaTree(Y,X,W0,tree,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[2,:]),np.mean(optim_info[3,:],0)) ### # works also with non tree-structured regularization. tree is ignored print '\nFISTA + Regression Fused-Lasso' param['regul'] = 'fused-lasso' param['lambda2'] = 0.001 param['lambda3'] = 0.001 (W, optim_info) = spams.fistaTree(Y,X,W0,tree,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[3,:],0)) ### print '\nISTA + Regression tree-l0' param['regul'] = 'tree-l0' (W, optim_info) = spams.fistaTree(Y,X,W0,tree,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[3,:],0)) ### print '\nFISTA + Regression tree-l2 with intercept' param['intercept'] = True param['regul'] = 'tree-l2' x1 = np.asfortranarray(np.concatenate((X,np.ones((X.shape[0],1))),1),dtype=myfloat) W01 = np.asfortranarray(np.concatenate((W0,np.zeros((1,W0.shape[1]))),0),dtype=myfloat) (W, optim_info) = spams.fistaTree(Y,x1,W01,tree,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[3,:],0)) ### param['intercept'] = False # Classification print '\nOne classification experiment' Y = np.asfortranarray(2 * np.asarray(np.random.normal(size = (100,Y.shape[1])) > 0,dtype=myfloat) - 1) print '\nFISTA + Logistic + tree-linf' param['regul'] = 'tree-linf' param['loss'] = 'logistic' param['lambda1'] = 0.001 (W, optim_info) = spams.fistaTree(Y,X,W0,tree,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[2,:]),np.mean(optim_info[3,:],0)) ### # can be used of course with other regularization functions, intercept,... # Multi-Class classification Y = np.asfortranarray(np.ceil(5 * np.random.random(size = (100,Y.shape[1]))) - 1,dtype=myfloat) param['loss'] = 'multi-logistic' param['regul'] = 'tree-l2' print '\nFISTA + Multi-Class Logistic + tree-l2' nclasses = np.max(Y[:])+1 W0 = np.zeros((X.shape[1],nclasses * Y.shape[1]),dtype=myfloat,order="FORTRAN") (W, optim_info) = spams.fistaTree(Y,X,W0,tree,True,**param) print 'mean loss: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[3,:],0)) # can be used of course with other regularization functions, intercept,... # Multi-Task regression Y = np.asfortranarray(np.random.normal(size = (100,100))) Y = np.asfortranarray(Y - np.tile(np.mean(Y,0),(Y.shape[0],1)),dtype=myfloat) Y = spams.normalize(Y) param['compute_gram'] = False param['verbose'] = True; # verbosity, False by default W0 = np.zeros((X.shape[1],Y.shape[1]),dtype=myfloat,order="FORTRAN") param['loss'] = 'square' print '\nFISTA + Regression multi-task-tree' param['regul'] = 'multi-task-tree' param['lambda2'] = 0.001 (W, optim_info) = spams.fistaTree(Y,X,W0,tree,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[2,:]),np.mean(optim_info[3,:],0)) # Multi-Task Classification print '\nFISTA + Logistic + multi-task-tree' param['regul'] = 'multi-task-tree' param['lambda2'] = 0.001 param['loss'] = 'logistic' Y = np.asfortranarray(2 * np.asarray(np.random.normal(size = (100,Y.shape[1])) > 0,dtype=myfloat) - 1) (W, optim_info) = spams.fistaTree(Y,X,W0,tree,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[2,:]),np.mean(optim_info[3,:],0)) # Multi-Class + Multi-Task Regularization param['verbose'] = False print '\nFISTA + Multi-Class Logistic +multi-task-tree' Y = np.asfortranarray(np.ceil(5 * np.random.random(size = (100,Y.shape[1]))) - 1,dtype=myfloat) param['loss'] = 'multi-logistic' param['regul'] = 'multi-task-tree' nclasses = np.max(Y[:])+1 W0 = np.zeros((X.shape[1],nclasses * Y.shape[1]),dtype=myfloat,order="FORTRAN") (W, optim_info) = spams.fistaTree(Y,X,W0,tree,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[2,:]),np.mean(optim_info[3,:],0)) # can be used of course with other regularization functions, intercept,... print '\nFISTA + Multi-Class Logistic +multi-task-tree + sparse matrix' nclasses = np.max(Y[:])+1 W0 = np.zeros((X.shape[1],nclasses * Y.shape[1]),dtype=myfloat,order="FORTRAN") X2 = ssp.csc_matrix(X) (W, optim_info) = spams.fistaTree(Y,X2,W0,tree,True,**param) print 'mean loss: %f, mean relative duality_gap: %f, number of iterations: %f' %(np.mean(optim_info[0,:],0),np.mean(optim_info[2,:]),np.mean(optim_info[3,:],0)) | 
Given a matrix X=[x1,…,xp]T in ℝm × p, and a matrix Y=[y1,…,yn], it solves the optimization problems presented in the previous section, with the same regularization functions as spams.proximalGraph. see usage details below:
| # # Name: fistaGraph # # Usage: spams.fistaGraph(Y,X,W0,graph,return_optim_info = False,numThreads =-1,max_it =1000,L0=1.0, # fixed_step=False,gamma=1.5,lambda1=1.0,delta=1.0,lambda2=0.,lambda3=0., # a=1.0,b=0.,c=1.0,tol=0.000001,it0=100,max_iter_backtracking=1000, # compute_gram=False,lin_admm=False,admm=False,intercept=False, # resetflow=False,regul="",loss="",verbose=False,pos=False,clever=False, # log=False,ista=False,subgrad=False,logName="",is_inner_weights=False, # inner_weights=None,size_group=1,sqrt_step=True,transpose=False, # linesearch_mode=0) # # Description: # fistaGraph solves sparse regularized problems. # X is a design matrix of size m x p # X=[x^1,...,x^n]', where the x_i's are the rows of X # Y=[y^1,...,y^n] is a matrix of size m x n # It implements the algorithms FISTA, ISTA and subgradient descent. # # It implements the algorithms FISTA, ISTA and subgradient descent for solving # # min_W loss(W) + lambda1 psi(W) # # The function psi are those used by proximalGraph (see documentation) # for the loss functions, see the documentation of fistaFlat # # This function can also handle intercepts (last row of W is not regularized), # and/or non-negativity constraints on W. # # Inputs: # Y: double dense m x n matrix # X: double dense or sparse m x p matrix # W0: double dense p x n matrix or p x Nn matrix (for multi-logistic loss) # initial guess # graph: struct (see documentation of proximalGraph) # return_optim_info: # if true the function will return a tuple of matrices. # loss: (choice of loss, see above) # regul: (choice of regularization, see function proximalFlat) # lambda1: (regularization parameter) # lambda2: (optional, regularization parameter, 0 by default) # lambda3: (optional, regularization parameter, 0 by default) # verbose: (optional, verbosity level, false by default) # pos: (optional, adds positivity constraints on the # coefficients, false by default) # numThreads: (optional, number of threads for exploiting # multi-core / multi-cpus. By default, it takes the value -1, # which automatically selects all the available CPUs/cores). # max_it: (optional, maximum number of iterations, 100 by default) # it0: (optional, frequency for computing duality gap, every 10 iterations by default) # tol: (optional, tolerance for stopping criteration, which is a relative duality gap # if it is available, or a relative change of parameters). # gamma: (optional, multiplier for increasing the parameter L in fista, 1.5 by default) # L0: (optional, initial parameter L in fista, 0.1 by default, should be small enough) # fixed_step: (deactive the line search for L in fista and use L0 instead) # compute_gram: (optional, pre-compute X^TX, false by default). # intercept: (optional, do not regularize last row of W, false by default). # ista: (optional, use ista instead of fista, false by default). # subgrad: (optional, if not ista, use subradient descent instead of fista, false by default). # a: # b: (optional, if subgrad, the gradient step is a/(t+b) # also similar options as proximalTree # # the function also implements the ADMM algorithm via an option admm=true. It is not documented # and you need to look at the source code to use it. # delta: undocumented; modify at your own risks! # c: undocumented; modify at your own risks! # max_iter_backtracking: undocumented; modify at your own risks! # lin_admm: undocumented; modify at your own risks! # admm: undocumented; modify at your own risks! # resetflow: undocumented; modify at your own risks! # clever: undocumented; modify at your own risks! # log: undocumented; modify at your own risks! # logName: undocumented; modify at your own risks! # is_inner_weights: undocumented; modify at your own risks! # inner_weights: undocumented; modify at your own risks! # sqrt_step: undocumented; modify at your own risks! # size_group: undocumented; modify at your own risks! # transpose: undocumented; modify at your own risks! # # Output: # W: double dense p x n matrix or p x Nn matrix (for multi-logistic loss) # optim: optional, double dense 4 x n matrix. # first row: values of the objective functions. # third row: values of the relative duality gap (if available) # fourth row: number of iterations # optim_info: vector of size 4, containing information of the optimization. # W = spams.fistaGraph(Y,X,W0,graph,return_optim_info = False,...) # (W,optim_info) = spams.fistaGraph(Y,X,W0,graph,return_optim_info = True,...) # # Authors: # Julien MAIRAL, 2010 (spams, matlab interface and documentation) # Jean-Paul CHIEZE 2011-2012 (python interface) # # Note: # Valid values for the regularization parameter (regul) are: # "l0", "l1", "l2", "linf", "l2-not-squared", "elastic-net", "fused-lasso", # "group-lasso-l2", "group-lasso-linf", "sparse-group-lasso-l2", # "sparse-group-lasso-linf", "l1l2", "l1linf", "l1l2+l1", "l1linf+l1", # "tree-l0", "tree-l2", "tree-linf", "graph", "graph-ridge", "graph-l2", # "multi-task-tree", "multi-task-graph", "l1linf-row-column", "trace-norm", # "trace-norm-vec", "rank", "rank-vec", "none" # | 
The following piece of code illustrates how to use this function. The following piece of code contains usage examples:
| import spams import numpy as np np.random.seed(0) num_threads = -1 # all cores (-1 by default) verbose = False # verbosity, false by default lambda1 = 0.1 # regularization ter it0 = 1 # frequency for duality gap computations max_it = 100 # maximum number of iterations L0 = 0.1 tol = 1e-5 intercept = False pos = False eta_g = np.array([1, 1, 1, 1, 1],dtype=myfloat) groups = ssp.csc_matrix(np.array([[0, 0, 0, 1, 0], [0, 0, 0, 0, 0], [0, 0, 0, 0, 0], [0, 0, 0, 0, 0], [0, 0, 1, 0, 0]],dtype=np.bool),dtype=np.bool) groups_var = ssp.csc_matrix(np.array([[1, 0, 0, 0, 0], [1, 0, 0, 0, 0], [1, 0, 0, 0, 0], [1, 1, 0, 0, 0], [0, 1, 0, 1, 0], [0, 1, 0, 1, 0], [0, 1, 0, 0, 1], [0, 0, 0, 0, 1], [0, 0, 0, 0, 1], [0, 0, 1, 0, 0]],dtype=np.bool),dtype=np.bool) graph = {'eta_g': eta_g,'groups' : groups,'groups_var' : groups_var} verbose = True X = np.asfortranarray(np.random.normal(size = (100,10))) X = np.asfortranarray(X - np.tile(np.mean(X,0),(X.shape[0],1)),dtype=myfloat) X = spams.normalize(X) Y = np.asfortranarray(np.random.normal(size = (100,1))) Y = np.asfortranarray(Y - np.tile(np.mean(Y,0),(Y.shape[0],1)),dtype=myfloat) Y = spams.normalize(Y) W0 = np.zeros((X.shape[1],Y.shape[1]),dtype=myfloat,order="FORTRAN") # Regression experiments # 100 regression problems with the same design matrix X. print '\nVarious regression experiments' compute_gram = True # print '\nFISTA + Regression graph' loss = 'square' regul = 'graph' tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul) tac = time.time() t = tac - tic print 'mean loss: %f, mean relative duality_gap: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),t,np.mean(optim_info[3,:])) # print '\nADMM + Regression graph' admm = True lin_admm = True c = 1 delta = 1 tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul,admm = admm,lin_admm = lin_admm,c = c,delta = delta) tac = time.time() t = tac - tic print 'mean loss: %f, mean relative duality_gap: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),t,np.mean(optim_info[3,:])) # admm = False max_it = 5 it0 = 1 tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul,admm = admm,lin_admm = lin_admm,c = c,delta = delta) tac = time.time() t = tac - tic print 'mean loss: %f, mean relative duality_gap: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),t,np.mean(optim_info[3,:])) # # works also with non graph-structured regularization. graph is ignored print '\nFISTA + Regression Fused-Lasso' regul = 'fused-lasso' lambda2 = 0.01 lambda3 = 0.01 tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul,admm = admm,lin_admm = lin_admm,c = c, lambda2 = lambda2,lambda3 = lambda3,delta = delta) tac = time.time() t = tac - tic print 'mean loss: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),t,np.mean(optim_info[3,:])) # print '\nFISTA + Regression graph with intercept' regul = 'graph' intercept = True tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul,admm = admm,lin_admm = lin_admm,c = c, lambda2 = lambda2,lambda3 = lambda3,delta = delta) tac = time.time() t = tac - tic print 'mean loss: %f, mean relative duality_gap: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),t,np.mean(optim_info[3,:])) intercept = False # Classification print '\nOne classification experiment' Y = np.asfortranarray( 2 * np.asfortranarray(np.random.normal(size = (100,Y.shape[1])) > 0,dtype = myfloat) -1) print '\nFISTA + Logistic + graph-linf' loss = 'logistic' regul = 'graph' lambda1 = 0.01 tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul,admm = admm,lin_admm = lin_admm,c = c, lambda2 = lambda2,lambda3 = lambda3,delta = delta) tac = time.time() t = tac - tic print 'mean loss: %f, mean relative duality_gap: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),t,np.mean(optim_info[3,:])) # # can be used of course with other regularization functions, intercept,... # Multi-Class classification Y = np.asfortranarray(np.ceil(5 * np.random.random(size = (100,Y.shape[1]))) - 1,dtype=myfloat) loss = 'multi-logistic' regul = 'graph' print '\nFISTA + Multi-Class Logistic + graph' nclasses = np.max(Y) + 1 W0 = np.zeros((X.shape[1],nclasses * Y.shape[1]),dtype=myfloat,order="FORTRAN") tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul,admm = admm,lin_admm = lin_admm,c = c, lambda2 = lambda2,lambda3 = lambda3,delta = delta) tac = time.time() t = tac - tic print 'mean loss: %f, mean relative duality_gap: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),t,np.mean(optim_info[3,:])) # # can be used of course with other regularization functions, intercept,... # Multi-Task regression Y = np.asfortranarray(np.random.normal(size = (100,Y.shape[1]))) Y = np.asfortranarray(Y - np.tile(np.mean(Y,0),(Y.shape[0],1)),dtype=myfloat) Y = spams.normalize(Y) W0 = W0 = np.zeros((X.shape[1],Y.shape[1]),dtype=myfloat,order="FORTRAN") compute_gram = False verbose = True loss = 'square' print '\nFISTA + Regression multi-task-graph' regul = 'multi-task-graph' lambda2 = 0.01 tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul,admm = admm,lin_admm = lin_admm,c = c, lambda2 = lambda2,lambda3 = lambda3,delta = delta) tac = time.time() t = tac - tic print 'mean loss: %f, mean relative duality_gap: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),t,np.mean(optim_info[3,:])) # # Multi-Task Classification print '\nFISTA + Logistic + multi-task-graph' regul = 'multi-task-graph' lambda2 = 0.01 loss = 'logistic' Y = np.asfortranarray( 2 * np.asfortranarray(np.random.normal(size = (100,Y.shape[1])) > 0,dtype = myfloat) -1) tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul,admm = admm,lin_admm = lin_admm,c = c, lambda2 = lambda2,lambda3 = lambda3,delta = delta) tac = time.time() t = tac - tic print 'mean loss: %f, mean relative duality_gap: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),t,np.mean(optim_info[3,:])) # Multi-Class + Multi-Task Regularization verbose = False print '\nFISTA + Multi-Class Logistic +multi-task-graph' Y = np.asfortranarray(np.ceil(5 * np.random.random(size = (100,Y.shape[1]))) - 1,dtype=myfloat) loss = 'multi-logistic' regul = 'multi-task-graph' nclasses = np.max(Y) + 1 W0 = np.zeros((X.shape[1],nclasses * Y.shape[1]),dtype=myfloat,order="FORTRAN") tic = time.time() (W, optim_info) = spams.fistaGraph( Y,X,W0,graph,True,numThreads = num_threads,verbose = verbose, lambda1 = lambda1,it0 = it0,max_it = max_it,L0 = L0,tol = tol, intercept = intercept,pos = pos,compute_gram = compute_gram, loss = loss,regul = regul,admm = admm,lin_admm = lin_admm,c = c, lambda2 = lambda2,lambda3 = lambda3,delta = delta) tac = time.time() t = tac - tic print 'mean loss: %f, mean relative duality_gap: %f, time: %f, number of iterations: %f' %(np.mean(optim_info[0,:]),np.mean(optim_info[2,:]),t,np.mean(optim_info[3,:])) # can be used of course with other regularization functions, intercept,... | 
Similarly, the toolbox handles the penalties of [24] with the following function
| # # The python function is not yet implemented. # | 
The following piece of code illustrates how to use this function.
The following problem is addressed here
| 
 | 
 | xi⊤w + δ − yi log(xi⊤w +δ) + λ ψ(w). | 
| # # The python function is not yet implemented. # | 
The following piece of code illustrates how to use this function.
This implements the incremental solver MISO [25].
| # # The python function is not yet implemented. # | 
The following piece of code illustrates how to use this function.
This implements the stochastic proximal gradient solver [26].
| # # The python function is not yet implemented. # | 
The following piece of code illustrates how to use this function.
 
 
