Small stuff, but this updates several obviously-stale man pages on SNESVI.

Ed

-- 
Ed Bueler
Dept of Math and Stat and Geophysical Institute
University of Alaska Fairbanks
Fairbanks, AK 99775-6660
301C Chapman and 410D Elvey
907 474-7693 and 907 474-7199  (fax 907 474-5394)
From c77a90c883c0f7a7b76d3aa0c8f6b3e79986df9e Mon Sep 17 00:00:00 2001
From: Ed Bueler <[email protected]>
Date: Fri, 27 Mar 2015 14:09:10 -0600
Subject: [PATCH] Fix obviously-wrong aspects of documentation on
 SNESVINEWTONRSLS and SNESVINEWTONSSLS.

---
 src/snes/impls/vi/rs/virs.c | 11 ++++-------
 src/snes/impls/vi/ss/viss.c | 18 +++++++-----------
 src/snes/impls/vi/vi.c      |  1 -
 3 files changed, 11 insertions(+), 19 deletions(-)

diff --git a/src/snes/impls/vi/rs/virs.c b/src/snes/impls/vi/rs/virs.c
index 5c31594..35dc91d 100644
--- a/src/snes/impls/vi/rs/virs.c
+++ b/src/snes/impls/vi/rs/virs.c
@@ -15,7 +15,7 @@
 .  snes - the SNES context
 
    Output parameter
-.  ISact - active set index set
+.  inact - inactive set index set
 
  */
 PetscErrorCode SNESVIGetInactiveSet(SNES snes,IS *inact)
@@ -712,7 +712,6 @@ PetscErrorCode SNESVISetRedundancyCheckMatlab(SNES snes,const char *func,mxArray
 
    Input Parameter:
 .  snes - the SNES context
-.  x - the solution vector
 
    Application Interface Routine: SNESSetUp()
 
@@ -769,18 +768,16 @@ PetscErrorCode SNESReset_VINEWTONRSLS(SNES snes)
       SNESVINEWTONRSLS - Reduced space active set solvers for variational inequalities based on Newton's method
 
    Options Database:
-+   -snes_vi_type <ss,rs,rsaug> a semi-smooth solver, a reduced space active set method, and a reduced space active set method that does not eliminate the active constraints from the Jacobian instead augments the Jacobian with additional variables that enforce the constraints
++   -snes_type <vinewtonssls,vinewtonrsls> a semi-smooth solver, a reduced space active set method
 -   -snes_vi_monitor - prints the number of active constraints at each iteration.
 
    Level: beginner
 
    References:
-   - T. S. Munson, and S. Benson. Flexible Complementarity Solvers for Large-Scale
+  - T. S. Munson, and S. Benson. Flexible Complementarity Solvers for Large-Scale
      Applications, Optimization Methods and Software, 21 (2006).
 
-.seealso:  SNESVISetVariableBounds(), SNESVISetComputeVariableBounds(), SNESCreate(), SNES, SNESSetType(), SNESVINEWTONRSLS, SNESVINEWTONSSLS, SNESNEWTONTR, SNESLineSearchSet(),
-           SNESLineSearchSetPostCheck(), SNESLineSearchNo(), SNESLineSearchCubic(), SNESLineSearchQuadratic(),
-           SNESLineSearchSet(), SNESLineSearchNoNorms(), SNESLineSearchSetPreCheck(), SNESLineSearchSetParams(), SNESLineSearchGetParams()
+.seealso:  SNESVISetVariableBounds(), SNESVISetComputeVariableBounds(), SNESCreate(), SNES, SNESSetType(), SNESVINEWTONSSLS, SNESNEWTONTR, SNESLineSearchSet(),SNESLineSearchSetPostCheck(), SNESLineSearchSetPreCheck()
 
 M*/
 #undef __FUNCT__
diff --git a/src/snes/impls/vi/ss/viss.c b/src/snes/impls/vi/ss/viss.c
index 214659d..929b546 100644
--- a/src/snes/impls/vi/ss/viss.c
+++ b/src/snes/impls/vi/ss/viss.c
@@ -49,7 +49,7 @@ PETSC_STATIC_INLINE PetscScalar DPhi(PetscScalar a,PetscScalar b)
 
    Input Parameters:
 .  snes - the SNES context
-.  x - current iterate
+.  X - current iterate
 .  functx - user defined function context
 
    Output Parameters:
@@ -219,15 +219,12 @@ PetscErrorCode SNESVIComputeMeritFunctionGradient(Mat H, Vec phi, Vec dpsi)
    Input Parameters:
 .  snes - the SNES context
 
-   Output Parameter:
-.  outits - number of iterations until termination
-
    Application Interface Routine: SNESSolve()
 
    Notes:
    This implements essentially a semismooth Newton method with a
-   line search. The default line search does not do any line seach
-   but rather takes a full newton step.
+   line search. The default line search does not do any line search
+   but rather takes a full Newton step.
 
    Developer Note: the code in this file should be slightly modified so that this routine need not exist and the SNESSolve_NEWTONLS() routine is called directly with the appropriate wrapped function and Jacobian evaluations
 
@@ -393,7 +390,6 @@ PetscErrorCode SNESSolve_VINEWTONSSLS(SNES snes)
 
    Input Parameter:
 .  snes - the SNES context
-.  x - the solution vector
 
    Application Interface Routine: SNESSetUp()
 
@@ -473,7 +469,7 @@ static PetscErrorCode SNESSetFromOptions_VINEWTONSSLS(PetscOptions *PetscOptions
       SNESVINEWTONSSLS - Semi-smooth solver for variational inequalities based on Newton's method
 
    Options Database:
-+   -snes_vi_type <ss,rs,rsaug> a semi-smooth solver, a reduced space active set method, and a reduced space active set method that does not eliminate the active constraints from the Jacobian instead augments the Jacobian with additional variables that enforce the constraints
++   -snes_type <vinewtonssls,vinewtonrsls> a semi-smooth solver, a reduced space active set method
 -   -snes_vi_monitor - prints the number of active constraints at each iteration.
 
    Level: beginner
@@ -481,10 +477,10 @@ static PetscErrorCode SNESSetFromOptions_VINEWTONSSLS(PetscOptions *PetscOptions
    References:
    - T. S. Munson, F. Facchinei, M. C. Ferris, A. Fischer, and C. Kanzow. The semismooth
      algorithm for large scale complementarity problems. INFORMS Journal on Computing, 13 (2001).
+   - T. S. Munson, and S. Benson. Flexible Complementarity Solvers for Large-Scale
+     Applications, Optimization Methods and Software, 21 (2006).
 
-.seealso:  SNESVISetVariableBounds(), SNESVISetComputeVariableBounds(), SNESCreate(), SNES, SNESSetType(), SNESVINEWTONRSLS, SNESVINEWTONSSLS, SNESNEWTONTR, SNESLineSearchSet(),
-           SNESLineSearchSetPostCheck(), SNESLineSearchNo(), SNESLineSearchCubic(), SNESLineSearchQuadratic(),
-           SNESLineSearchSet(), SNESLineSearchNoNorms(), SNESLineSearchSetPreCheck(), SNESLineSearchSetParams(), SNESLineSearchGetParams()
+.seealso:  SNESVISetVariableBounds(), SNESVISetComputeVariableBounds(), SNESCreate(), SNES, SNESSetType(), SNESVINEWTONRSLS, SNESNEWTONTR, SNESLineSearchSet(),SNESLineSearchSetPostCheck(), SNESLineSearchSetPreCheck()
 
 M*/
 #undef __FUNCT__
diff --git a/src/snes/impls/vi/vi.c b/src/snes/impls/vi/vi.c
index 31e8ebf..846621d 100644
--- a/src/snes/impls/vi/vi.c
+++ b/src/snes/impls/vi/vi.c
@@ -399,7 +399,6 @@ PetscErrorCode SNESVIDMComputeVariableBounds(SNES snes,Vec xl, Vec xu)
 
    Input Parameter:
 .  snes - the SNES context
-.  x - the solution vector
 
    Application Interface Routine: SNESSetUp()
 
-- 
1.9.1

Reply via email to