[Robast-commits] r330 - branches/robast-0.7/pkg/ROptEst/R branches/robast-0.7/pkg/ROptEst/chm branches/robast-0.7/pkg/ROptEst/man branches/robast-0.7/pkg/ROptEstOld/chm branches/robast-0.7/pkg/RandVar branches/robast-0.7/pkg/RandVar/chm branches/robast-0.7/pkg/RandVar/inst/doc branches/robast-0.7/pkg/RobAStBase/chm branches/robast-0.7/pkg/RobLox/chm branches/robast-0.7/pkg/RobRex/chm pkg/RandVar pkg/RandVar/chm pkg/RandVar/inst/doc pkg/RandVar/man
noreply at r-forge.r-project.org
noreply at r-forge.r-project.org
Fri Jul 31 14:05:05 CEST 2009
Author: ruckdeschel
Date: 2009-07-31 14:05:04 +0200 (Fri, 31 Jul 2009)
New Revision: 330
Modified:
branches/robast-0.7/pkg/ROptEst/R/LowerCaseMultivariate.R
branches/robast-0.7/pkg/ROptEst/R/getInfRobIC_asBias.R
branches/robast-0.7/pkg/ROptEst/R/getInfRobIC_asHampel.R
branches/robast-0.7/pkg/ROptEst/chm/00Index.html
branches/robast-0.7/pkg/ROptEst/chm/0ROptEst-package.html
branches/robast-0.7/pkg/ROptEst/chm/ROptEst.chm
branches/robast-0.7/pkg/ROptEst/chm/ROptEst.hhp
branches/robast-0.7/pkg/ROptEst/chm/ROptEst.toc
branches/robast-0.7/pkg/ROptEst/chm/getInfRobIC.html
branches/robast-0.7/pkg/ROptEst/chm/minmaxBias.html
branches/robast-0.7/pkg/ROptEst/chm/optIC.html
branches/robast-0.7/pkg/ROptEst/chm/roptest.html
branches/robast-0.7/pkg/ROptEst/man/minmaxBias.Rd
branches/robast-0.7/pkg/ROptEstOld/chm/00Index.html
branches/robast-0.7/pkg/ROptEstOld/chm/ROptEstOld.chm
branches/robast-0.7/pkg/ROptEstOld/chm/ROptEstOld.toc
branches/robast-0.7/pkg/RandVar/DESCRIPTION
branches/robast-0.7/pkg/RandVar/chm/0RandVar-package.html
branches/robast-0.7/pkg/RandVar/chm/EuclRandVarList-class.html
branches/robast-0.7/pkg/RandVar/chm/EuclRandVariable-class.html
branches/robast-0.7/pkg/RandVar/chm/RandVar.chm
branches/robast-0.7/pkg/RandVar/inst/doc/RandVar.pdf
branches/robast-0.7/pkg/RobAStBase/chm/00Index.html
branches/robast-0.7/pkg/RobAStBase/chm/0RobAStBase-package.html
branches/robast-0.7/pkg/RobAStBase/chm/RobAStBase.chm
branches/robast-0.7/pkg/RobAStBase/chm/RobAStBase.toc
branches/robast-0.7/pkg/RobAStBase/chm/comparePlot.html
branches/robast-0.7/pkg/RobAStBase/chm/infoPlot.html
branches/robast-0.7/pkg/RobAStBase/chm/oneStepEstimator.html
branches/robast-0.7/pkg/RobAStBase/chm/plot-methods.html
branches/robast-0.7/pkg/RobLox/chm/00Index.html
branches/robast-0.7/pkg/RobLox/chm/RobLox.chm
branches/robast-0.7/pkg/RobLox/chm/RobLox.toc
branches/robast-0.7/pkg/RobLox/chm/roblox.html
branches/robast-0.7/pkg/RobLox/chm/rowRoblox.html
branches/robast-0.7/pkg/RobRex/chm/00Index.html
branches/robast-0.7/pkg/RobRex/chm/rgsOptIC.AL.html
branches/robast-0.7/pkg/RobRex/chm/rgsOptIC.ALc.html
branches/robast-0.7/pkg/RobRex/chm/rgsOptIC.ALs.html
branches/robast-0.7/pkg/RobRex/chm/rgsOptIC.BM.html
branches/robast-0.7/pkg/RobRex/chm/rgsOptIC.M.html
branches/robast-0.7/pkg/RobRex/chm/rgsOptIC.MK.html
branches/robast-0.7/pkg/RobRex/chm/rgsOptIC.Mc.html
branches/robast-0.7/pkg/RobRex/chm/rgsOptIC.Ms.html
pkg/RandVar/DESCRIPTION
pkg/RandVar/chm/00Index.html
pkg/RandVar/chm/EuclRandVarList-class.html
pkg/RandVar/chm/EuclRandVariable-class.html
pkg/RandVar/chm/RandVar.chm
pkg/RandVar/chm/RandVar.hhp
pkg/RandVar/inst/doc/RandVar.pdf
pkg/RandVar/man/EuclRandVarList-class.Rd
pkg/RandVar/man/EuclRandVariable-class.Rd
Log:
-lots of chm files updated;
-DESCRIPTION files for RandVar for both trunc and branch updated; trunc to 0.7.1 and branch to 0.7.5 (to fit in the general 0.7 scheme)
-fixed a warning issue in .Rd files of RandVar
Modified: branches/robast-0.7/pkg/ROptEst/R/LowerCaseMultivariate.R
===================================================================
--- branches/robast-0.7/pkg/ROptEst/R/LowerCaseMultivariate.R 2009-07-21 12:17:02 UTC (rev 329)
+++ branches/robast-0.7/pkg/ROptEst/R/LowerCaseMultivariate.R 2009-07-31 12:05:04 UTC (rev 330)
@@ -1,6 +1,6 @@
.LowerCaseMultivariate <- function(L2deriv, neighbor, biastype,
normtype, Distr, trafo, z.start,
- A.start, z.comp, A.comp, maxiter, tol){
+ A.start, z.comp, A.comp, maxiter, tol, verbose = FALSE){
w <- new("HampelWeight")
@@ -26,7 +26,7 @@
A[A.comp] <- param[1:lA.comp]
z <- numeric(k)
z[z.comp] <- param[(lA.comp+1):length(param)]
-
+
# if(is(normtype,"SelfNorm"))
# A <- A/max(A)
@@ -51,6 +51,12 @@
erg <- E1/sum(diag(stA %*% t(trafo)))
clip(w0) <- 1/erg
w <<- w0
+ if(verbose){
+ cat("trying to find lower case solution;\n")
+ cat("current Lagrange Multiplier value:\n")
+ print(list(A=A, z=z,erg=erg))
+ }
+
return(erg)
}
Modified: branches/robast-0.7/pkg/ROptEst/R/getInfRobIC_asBias.R
===================================================================
--- branches/robast-0.7/pkg/ROptEst/R/getInfRobIC_asBias.R 2009-07-21 12:17:02 UTC (rev 329)
+++ branches/robast-0.7/pkg/ROptEst/R/getInfRobIC_asBias.R 2009-07-31 12:05:04 UTC (rev 330)
@@ -65,11 +65,11 @@
z.comp <- comp$"z.comp"
A.comp <- comp$"A.comp"
- minmaxBias(L2deriv = L2deriv, neighbor = neighbor,
+ return(minmaxBias(L2deriv = L2deriv, neighbor = neighbor,
biastype = biastype(risk), normtype = normtype(risk),
Distr = Distr, z.start = z.start, A.start = A.start,
z.comp = z.comp, A.comp = A.comp, trafo = trafo,
- maxiter = maxiter, tol = tol)
+ maxiter = maxiter, tol = tol, verbose = verbose))
})
@@ -153,12 +153,14 @@
neighbor = "ContNeighborhood",
biastype = "BiasType"),
function(L2deriv, neighbor, biastype, normtype, Distr,
- z.start, A.start, z.comp, A.comp, trafo, maxiter, tol){
+ z.start, A.start, z.comp, A.comp, trafo, maxiter, tol,
+ verbose = FALSE){
DA.comp <- abs(trafo) %*% A.comp != 0
eerg <- .LowerCaseMultivariate(L2deriv, neighbor, biastype,
normtype, Distr, trafo, z.start,
- A.start, z.comp = z.comp, A.comp = DA.comp, maxiter, tol)
+ A.start, z.comp = z.comp, A.comp = DA.comp, maxiter, tol,
+ verbose = verbose)
erg <- eerg$erg
b <- 1/erg$value
Modified: branches/robast-0.7/pkg/ROptEst/R/getInfRobIC_asHampel.R
===================================================================
--- branches/robast-0.7/pkg/ROptEst/R/getInfRobIC_asHampel.R 2009-07-21 12:17:02 UTC (rev 329)
+++ branches/robast-0.7/pkg/ROptEst/R/getInfRobIC_asHampel.R 2009-07-31 12:05:04 UTC (rev 330)
@@ -14,59 +14,59 @@
b <- risk at bound
if(checkBounds){
- bmax <- abs(as.vector(A))*max(abs(q(L2deriv)(0)), q(L2deriv)(1))
- if(b >= bmax){
- if(warn) cat("'b >= maximum asymptotic bias' => (classical) optimal IC\n",
- "in sense of Cramer-Rao bound is returned\n")
- res <- getInfRobIC(L2deriv = L2deriv, risk = asCov(),
- neighbor = neighbor, Finfo = Finfo, trafo = trafo,
- verbose = verbose)
- res <- c(res, list(biastype = biastype, normtype = NormType()))
- Cov <- res$risk$asCov
- r <- neighbor at radius
- res$risk$asBias <- list(value = b, biastype = biastype,
- normtype = normtype,
- neighbortype = class(neighbor))
- res$risk$asMSE <- list(value = Cov + r^2*b^2,
- r = r,
- at = neighbor)
- return(res)
- }
+ bmax <- abs(as.vector(A))*max(abs(q(L2deriv)(0)), q(L2deriv)(1))
+ if(b >= bmax){
+ if(warn) cat("'b >= maximum asymptotic bias' => (classical) optimal IC\n",
+ "in sense of Cramer-Rao bound is returned\n")
+ res <- getInfRobIC(L2deriv = L2deriv, risk = asCov(),
+ neighbor = neighbor, Finfo = Finfo, trafo = trafo,
+ verbose = verbose)
+ res <- c(res, list(biastype = biastype, normtype = NormType()))
+ Cov <- res$risk$asCov
+ r <- neighbor at radius
+ res$risk$asBias <- list(value = b, biastype = biastype,
+ normtype = normtype,
+ neighbortype = class(neighbor))
+ res$risk$asMSE <- list(value = Cov + r^2*b^2,
+ r = r,
+ at = neighbor)
+ return(res)
+ }
- if(!noLow){
- res <- getInfRobIC(L2deriv = L2deriv, risk = asBias(biastype = biastype),
- neighbor = neighbor, symm = symm,
- trafo = trafo, maxiter = maxiter, tol = tol, Finfo = Finfo,
- warn = warn, verbose = verbose)
- bmin <- res$b
- cat("minimal bound:\t", bmin, "\n")
+ if(!noLow){
+ res <- getInfRobIC(L2deriv = L2deriv, risk = asBias(biastype = biastype),
+ neighbor = neighbor, symm = symm,
+ trafo = trafo, maxiter = maxiter, tol = tol, Finfo = Finfo,
+ warn = warn, verbose = verbose)
+ bmin <- res$b
+ cat("minimal bound:\t", bmin, "\n")
}else{
bmin <- b/2
}
- if(b <= bmin){
- if(warn) cat("'b <= minimum asymptotic bias'\n",
- "=> the minimum asymptotic bias (lower case) solution is returned\n")
- Risk <- list(asMSE = res$risk$asCov + neighbor at radius^2*bmin^2)
- res$risk <- c(Risk, res$risk)
- return(res)
- }
- # bmin <- getAsRisk(risk = asBias(biastype = biastype, normtype = normtype),
- # L2deriv = L2deriv, neighbor = neighbor,
- # biastype = biastype, trafo = trafo, Finfo = Finfo,
- # warn = warn)$asBias
- # if(b <= bmin){
- # if(warn) cat("'b <= minimum asymptotic bias'\n",
- # "=> the minimum asymptotic bias (lower case) solution is returned\n")
- # res <- getInfRobIC(L2deriv = L2deriv, risk = asBias(biastype = biastype),
- # neighbor = neighbor, symm = symm,
- # trafo = trafo, maxiter = maxiter, tol = tol, Finfo = Finfo,
- # warn = warn)
- # Risk <- list(asMSE = res$risk$asCov + neighbor at radius^2*bmin^2)
- # res$risk <- c(Risk, res$risk)
- # return(res)
- # }
+ if(b <= bmin){
+ if(warn) cat("'b <= minimum asymptotic bias'\n",
+ "=> the minimum asymptotic bias (lower case) solution is returned\n")
+ Risk <- list(asMSE = res$risk$asCov + neighbor at radius^2*bmin^2)
+ res$risk <- c(Risk, res$risk)
+ return(res)
}
+# bmin <- getAsRisk(risk = asBias(biastype = biastype, normtype = normtype),
+# L2deriv = L2deriv, neighbor = neighbor,
+# biastype = biastype, trafo = trafo, Finfo = Finfo,
+# warn = warn)$asBias
+# if(b <= bmin){
+# if(warn) cat("'b <= minimum asymptotic bias'\n",
+# "=> the minimum asymptotic bias (lower case) solution is returned\n")
+# res <- getInfRobIC(L2deriv = L2deriv, risk = asBias(biastype = biastype),
+# neighbor = neighbor, symm = symm,
+# trafo = trafo, maxiter = maxiter, tol = tol, Finfo = Finfo,
+# warn = warn)
+# Risk <- list(asMSE = res$risk$asCov + neighbor at radius^2*bmin^2)
+# res$risk <- c(Risk, res$risk)
+# return(res)
+# }
+ }
c0 <- b/as.vector(A)
if(is(symm, "SphericalSymmetry"))
S <- symm at SymmCenter == 0
@@ -151,53 +151,53 @@
b <- risk at bound
if(checkBounds){
- ClassIC <- trafo %*% solve(Finfo) %*% L2deriv
- lower <- q(Distr)(getdistrOption("TruncQuantile"))
- upper <- q(Distr)(1-getdistrOption("TruncQuantile"))
- x <- seq(from = lower, to = upper, by = 0.01)
- bmax <- evalRandVar(ClassIC, as.matrix(x))^2
- bmax <- sqrt(max(colSums(bmax)))
- cat("numerical approximation of maximal bound:\t", bmax, "\n")
- if(b >= bmax){
- if(warn) cat("'b >= maximum asymptotic bias' => (classical) optimal IC\n",
- "in sense of Cramer-Rao bound is returned\n")
- res <- getInfRobIC(L2deriv = L2deriv, risk = asCov(), neighbor = neighbor,
- Distr = Distr, Finfo = Finfo, trafo = trafo,
- QuadForm = std, verbose = verbose)
- res <- c(res, list(biastype = biastype, normtype = normtype))
- trAsCov <- sum(diag(std%*%res$risk$asCov));
- r <- neighbor at radius
- res$risk$trAsCov <- list(value = trAsCov, normtype = normtype)
- res$risk$asBias <- list(value = b, biastype = biastype,
- normtype = normtype,
- neighbortype = class(neighbor))
- res$risk$asMSE <- list(value = trAsCov + r^2*b^2,
- r = r,
- at = neighbor)
- return(res)
- }
+ ClassIC <- trafo %*% solve(Finfo) %*% L2deriv
+ lower <- q(Distr)(getdistrOption("TruncQuantile"))
+ upper <- q(Distr)(1-getdistrOption("TruncQuantile"))
+ x <- seq(from = lower, to = upper, length = 1000)
+ bmax <- sapply(x,function(x) evalRandVar(ClassIC,x))
+ bmax <- sqrt(max(colSums(bmax^2)))
+ cat("numerical approximation of maximal bound:\t", bmax, "\n")
+ if(b >= bmax){
+ if(warn) cat("'b >= maximum asymptotic bias' => (classical) optimal IC\n",
+ "in sense of Cramer-Rao bound is returned\n")
+ res <- getInfRobIC(L2deriv = L2deriv, risk = asCov(), neighbor = neighbor,
+ Distr = Distr, Finfo = Finfo, trafo = trafo,
+ QuadForm = std, verbose = verbose)
+ res <- c(res, list(biastype = biastype, normtype = normtype))
+ trAsCov <- sum(diag(std%*%res$risk$asCov));
+ r <- neighbor at radius
+ res$risk$trAsCov <- list(value = trAsCov, normtype = normtype)
+ res$risk$asBias <- list(value = b, biastype = biastype,
+ normtype = normtype,
+ neighbortype = class(neighbor))
+ res$risk$asMSE <- list(value = trAsCov + r^2*b^2,
+ r = r,
+ at = neighbor)
+ return(res)
+ }
- res <- getInfRobIC(L2deriv = L2deriv,
- risk = asBias(biastype = biastype, normtype = normtype),
- neighbor = neighbor, Distr = Distr, DistrSymm = DistrSymm,
- L2derivSymm = L2derivSymm, L2derivDistrSymm = L2derivDistrSymm,
- z.start = z.start, A.start = A.start, trafo = trafo,
- maxiter = maxiter, tol = tol, warn = warn, Finfo = Finfo,
- verbose = verbose)
- bmin <- res$b
+ res <- getInfRobIC(L2deriv = L2deriv,
+ risk = asBias(biastype = biastype, normtype = normtype),
+ neighbor = neighbor, Distr = Distr, DistrSymm = DistrSymm,
+ L2derivSymm = L2derivSymm, L2derivDistrSymm = L2derivDistrSymm,
+ z.start = z.start, A.start = A.start, trafo = trafo,
+ maxiter = maxiter, tol = tol, warn = warn, Finfo = Finfo,
+ verbose = verbose)
+ bmin <- res$b
- cat("minimal bound:\t", bmin, "\n")
- if(b <= bmin){
- if(warn) cat("'b <= minimum asymptotic bias'\n",
- "=> the minimum asymptotic bias (lower case) solution is returned\n")
+ cat("minimal bound:\t", bmin, "\n")
+ if(b <= bmin){
+ if(warn) cat("'b <= minimum asymptotic bias'\n",
+ "=> the minimum asymptotic bias (lower case) solution is returned\n")
- asMSE <- sum(diag(std%*%res$risk$asCov)) + neighbor at radius^2*bmin^2
- if(!is.null(res$risk$asMSE)) res$risk$asMSE <- asMSE
- else res$risk <- c(list(asMSE = asMSE), res$risk)
+ asMSE <- sum(diag(std%*%res$risk$asCov)) + neighbor at radius^2*bmin^2
+ if(!is.null(res$risk$asMSE)) res$risk$asMSE <- asMSE
+ else res$risk <- c(list(asMSE = asMSE), res$risk)
- return(res)
- }
+ return(res)
}
+ }
comp <- .getComp(L2deriv, DistrSymm, L2derivSymm, L2derivDistrSymm)
Modified: branches/robast-0.7/pkg/ROptEst/chm/00Index.html
===================================================================
--- branches/robast-0.7/pkg/ROptEst/chm/00Index.html 2009-07-21 12:17:02 UTC (rev 329)
+++ branches/robast-0.7/pkg/ROptEst/chm/00Index.html 2009-07-31 12:05:04 UTC (rev 330)
@@ -22,37 +22,36 @@
<a href="#R">R</a>
<a href="#U">U</a>
</p>
-<table width="100%">
-</table>
+
<h2><a name=" ">-- --</a></h2>
<table width="100%">
<tr><td width="25%"><a href="0ROptEst-package.html">ROptEst-package</a></td>
-<td>Optimally robust estimation </td></tr>
+<td>Optimally robust estimation</td></tr>
</table>
<h2><a name="C">-- C --</a></h2>
<table width="100%">
<tr><td width="25%"><a href="cniperCont.html">cniperCont</a></td>
-<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. </td></tr>
+<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.</td></tr>
<tr><td width="25%"><a href="cniperCont.html">cniperCont,IC,IC,L2ParamFamily,ContNeighborhood,asMSE-method</a></td>
-<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. </td></tr>
+<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.</td></tr>
<tr><td width="25%"><a href="cniperCont.html">cniperCont-methods</a></td>
-<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. </td></tr>
+<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.</td></tr>
<tr><td width="25%"><a href="cniperCont.html">cniperPoint</a></td>
-<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. </td></tr>
+<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.</td></tr>
<tr><td width="25%"><a href="cniperCont.html">cniperPoint,L2ParamFamily,ContNeighborhood,asMSE-method</a></td>
-<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. </td></tr>
+<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.</td></tr>
<tr><td width="25%"><a href="cniperCont.html">cniperPoint-methods</a></td>
-<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. </td></tr>
+<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.</td></tr>
<tr><td width="25%"><a href="cniperCont.html">cniperPointPlot</a></td>
-<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. </td></tr>
+<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.</td></tr>
<tr><td width="25%"><a href="cniperCont.html">cniperPointPlot,L2ParamFamily,ContNeighborhood,asMSE-method</a></td>
-<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. </td></tr>
+<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.</td></tr>
<tr><td width="25%"><a href="cniperCont.html">cniperPointPlot-methods</a></td>
-<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. </td></tr>
+<td>Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.</td></tr>
</table>
<h2><a name="G">-- G --</a></h2>
@@ -115,11 +114,11 @@
<tr><td width="25%"><a href="getFixClip.html">getFixClip-methods</a></td>
<td>Generic Function for the Computation of the Optimal Clipping Bound</td></tr>
<tr><td width="25%"><a href="getFixRobIC.html">getFixRobIC</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getFixRobIC.html">getFixRobIC,Norm,fiUnOvShoot,UncondNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getFixRobIC.html">getFixRobIC-methods</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getIneffDiff.html">getIneffDiff</a></td>
<td>Generic Function for the Computation of Inefficiency Differences</td></tr>
<tr><td width="25%"><a href="getIneffDiff.html">getIneffDiff,numeric,L2ParamFamily,UncondNeighborhood,asMSE-method</a></td>
@@ -171,43 +170,43 @@
<tr><td width="25%"><a href="getInfGamma.html">getInfGamma-methods</a></td>
<td>Generic Function for the Computation of the Optimal Clipping Bound</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,RealRandVariable,asBias,ContNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,RealRandVariable,asCov,ContNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,RealRandVariable,asGRisk,ContNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,RealRandVariable,asHampel,ContNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,UnivariateDistribution,asBias,UncondNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,UnivariateDistribution,asCov,ContNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,UnivariateDistribution,asCov,TotalVarNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,UnivariateDistribution,asGRisk,UncondNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,UnivariateDistribution,asHampel,UncondNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC,UnivariateDistribution,asUnOvShoot,UncondNeighborhood-method</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfRobIC.html">getInfRobIC-methods</a></td>
-<td>Generic Function for the Computation of Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="getInfStand.html">getInfStand</a></td>
-<td>Generic Function for the Computation of the Standardizing Matrix </td></tr>
+<td>Generic Function for the Computation of the Standardizing Matrix</td></tr>
<tr><td width="25%"><a href="getInfStand.html">getInfStand,RealRandVariable,ContNeighborhood,BiasType-method</a></td>
-<td>Generic Function for the Computation of the Standardizing Matrix </td></tr>
+<td>Generic Function for the Computation of the Standardizing Matrix</td></tr>
<tr><td width="25%"><a href="getInfStand.html">getInfStand,UnivariateDistribution,ContNeighborhood,asymmetricBias-method</a></td>
-<td>Generic Function for the Computation of the Standardizing Matrix </td></tr>
+<td>Generic Function for the Computation of the Standardizing Matrix</td></tr>
<tr><td width="25%"><a href="getInfStand.html">getInfStand,UnivariateDistribution,ContNeighborhood,BiasType-method</a></td>
-<td>Generic Function for the Computation of the Standardizing Matrix </td></tr>
+<td>Generic Function for the Computation of the Standardizing Matrix</td></tr>
<tr><td width="25%"><a href="getInfStand.html">getInfStand,UnivariateDistribution,ContNeighborhood,onesidedBias-method</a></td>
-<td>Generic Function for the Computation of the Standardizing Matrix </td></tr>
+<td>Generic Function for the Computation of the Standardizing Matrix</td></tr>
<tr><td width="25%"><a href="getInfStand.html">getInfStand,UnivariateDistribution,TotalVarNeighborhood,BiasType-method</a></td>
-<td>Generic Function for the Computation of the Standardizing Matrix </td></tr>
+<td>Generic Function for the Computation of the Standardizing Matrix</td></tr>
<tr><td width="25%"><a href="getInfStand.html">getInfStand-methods</a></td>
-<td>Generic Function for the Computation of the Standardizing Matrix </td></tr>
+<td>Generic Function for the Computation of the Standardizing Matrix</td></tr>
<tr><td width="25%"><a href="getInfV.html">getInfV</a></td>
<td>Generic Function for the Computation of the asymptotic Variance of a Hampel type IC</td></tr>
<tr><td width="25%"><a href="getInfV.html">getInfV,RealRandVariable,ContNeighborhood,BiasType-method</a></td>
@@ -289,19 +288,19 @@
<table width="100%">
<tr><td width="25%"><a href="minmaxBias.html">minmaxBias</a></td>
-<td>Generic Function for the Computation of Bias-Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Bias-Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="minmaxBias.html">minmaxBias,RealRandVariable,ContNeighborhood,BiasType-method</a></td>
-<td>Generic Function for the Computation of Bias-Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Bias-Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="minmaxBias.html">minmaxBias,UnivariateDistribution,ContNeighborhood,asymmetricBias-method</a></td>
-<td>Generic Function for the Computation of Bias-Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Bias-Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="minmaxBias.html">minmaxBias,UnivariateDistribution,ContNeighborhood,BiasType-method</a></td>
-<td>Generic Function for the Computation of Bias-Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Bias-Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="minmaxBias.html">minmaxBias,UnivariateDistribution,ContNeighborhood,onesidedBias-method</a></td>
-<td>Generic Function for the Computation of Bias-Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Bias-Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="minmaxBias.html">minmaxBias,UnivariateDistribution,TotalVarNeighborhood,BiasType-method</a></td>
-<td>Generic Function for the Computation of Bias-Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Bias-Optimally Robust ICs</td></tr>
<tr><td width="25%"><a href="minmaxBias.html">minmaxBias-methods</a></td>
-<td>Generic Function for the Computation of Bias-Optimally Robust ICs </td></tr>
+<td>Generic Function for the Computation of Bias-Optimally Robust ICs</td></tr>
</table>
<h2><a name="O">-- O --</a></h2>
@@ -339,19 +338,19 @@
<tr><td width="25%"><a href="radiusMinimaxIC.html">radiusMinimaxIC-methods</a></td>
<td>Generic function for the computation of the radius minimax IC</td></tr>
<tr><td width="25%"><a href="0ROptEst-package.html">ROptEst</a></td>
-<td>Optimally robust estimation </td></tr>
+<td>Optimally robust estimation</td></tr>
<tr><td width="25%"><a href="roptest.html">roptest</a></td>
-<td>Optimally robust estimation </td></tr>
+<td>Optimally robust estimation</td></tr>
</table>
<h2><a name="U">-- U --</a></h2>
<table width="100%">
<tr><td width="25%"><a href="updateNorm-methods.html">updateNorm</a></td>
-<td>Methods for Function updateNorm in Package ‘ROptEst’ </td></tr>
+<td>Methods for Function updateNorm in Package 'ROptEst'</td></tr>
<tr><td width="25%"><a href="updateNorm-methods.html">updateNorm,SelfNorm-method</a></td>
-<td>Methods for Function updateNorm in Package ‘ROptEst’ </td></tr>
+<td>Methods for Function updateNorm in Package 'ROptEst'</td></tr>
<tr><td width="25%"><a href="updateNorm-methods.html">updateNorm-methods</a></td>
-<td>Methods for Function updateNorm in Package ‘ROptEst’ </td></tr>
+<td>Methods for Function updateNorm in Package 'ROptEst'</td></tr>
</table>
</body></html>
Modified: branches/robast-0.7/pkg/ROptEst/chm/0ROptEst-package.html
===================================================================
--- branches/robast-0.7/pkg/ROptEst/chm/0ROptEst-package.html 2009-07-21 12:17:02 UTC (rev 329)
+++ branches/robast-0.7/pkg/ROptEst/chm/0ROptEst-package.html 2009-07-31 12:05:04 UTC (rev 330)
@@ -33,10 +33,10 @@
<td align="left"> Version: </td> <td align="left"> 0.7 </td>
</tr>
<tr>
- <td align="left"> Date: </td> <td align="left"> 2008-11-27 </td>
+ <td align="left"> Date: </td> <td align="left"> 2009-07-16 </td>
</tr>
<tr>
- <td align="left"> Depends: </td> <td align="left"> R(>= 2.7.0), methods, distr(>= 2.0), distrEx(>= 2.0), distrMod(>= 2.0), RandVar(>= 0.6.4), RobAStBase</td>
+ <td align="left"> Depends: </td> <td align="left"> R(>= 2.7.0), methods, distr(>= 2.0), distrEx(>= 2.0),distrMod(>= 2.0), RandVar(>= 0.6.4), RobAStBase</td>
</tr>
<tr>
<td align="left"> LazyLoad: </td> <td align="left"> yes</td>
Modified: branches/robast-0.7/pkg/ROptEst/chm/ROptEst.chm
===================================================================
(Binary files differ)
Modified: branches/robast-0.7/pkg/ROptEst/chm/ROptEst.hhp
===================================================================
--- branches/robast-0.7/pkg/ROptEst/chm/ROptEst.hhp 2009-07-21 12:17:02 UTC (rev 329)
+++ branches/robast-0.7/pkg/ROptEst/chm/ROptEst.hhp 2009-07-31 12:05:04 UTC (rev 330)
@@ -37,4 +37,6 @@
optRisk.html
radiusMinimaxIC.html
roptest.html
+trAsCov-class.html
+trFiCov-class.html
updateNorm-methods.html
Modified: branches/robast-0.7/pkg/ROptEst/chm/ROptEst.toc
===================================================================
--- branches/robast-0.7/pkg/ROptEst/chm/ROptEst.toc 2009-07-21 12:17:02 UTC (rev 329)
+++ branches/robast-0.7/pkg/ROptEst/chm/ROptEst.toc 2009-07-31 12:05:04 UTC (rev 330)
@@ -619,7 +619,7 @@
<param name="Local" value="getRiskIC.html">
</OBJECT>
<LI> <OBJECT type="text/sitemap">
-<param name="Name" value="Generic Function for the Computation of Bias-Optimally Robust ICs ">
+<param name="Name" value="Generic Function for the Computation of Bias-Optimally Robust ICs">
<param name="Local" value="minmaxBias.html">
</OBJECT>
<LI> <OBJECT type="text/sitemap">
@@ -635,14 +635,14 @@
<param name="Local" value="leastFavorableRadius.html">
</OBJECT>
<LI> <OBJECT type="text/sitemap">
+<param name="Name" value="Generic Function for the Computation of Optimally Robust ICs">
+<param name="Local" value="getFixRobIC.html">
+</OBJECT>
+<LI> <OBJECT type="text/sitemap">
<param name="Name" value="Generic function for the computation of optimally robust ICs">
<param name="Local" value="optIC.html">
</OBJECT>
<LI> <OBJECT type="text/sitemap">
-<param name="Name" value="Generic Function for the Computation of Optimally Robust ICs ">
-<param name="Local" value="getInfRobIC.html">
-</OBJECT>
-<LI> <OBJECT type="text/sitemap">
<param name="Name" value="Generic function for the computation of the asymptotic bias for an IC">
<param name="Local" value="getBiasIC.html">
</OBJECT>
@@ -660,27 +660,27 @@
</OBJECT>
<LI> <OBJECT type="text/sitemap">
<param name="Name" value="Generic Function for the Computation of the Optimal Clipping Bound">
-<param name="Local" value="getInfGamma.html">
+<param name="Local" value="getFixClip.html">
</OBJECT>
<LI> <OBJECT type="text/sitemap">
<param name="Name" value="Generic function for the computation of the radius minimax IC">
<param name="Local" value="radiusMinimaxIC.html">
</OBJECT>
<LI> <OBJECT type="text/sitemap">
-<param name="Name" value="Generic Function for the Computation of the Standardizing Matrix ">
+<param name="Name" value="Generic Function for the Computation of the Standardizing Matrix">
<param name="Local" value="getInfStand.html">
</OBJECT>
<LI> <OBJECT type="text/sitemap">
-<param name="Name" value="Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points. ">
+<param name="Name" value="Generic Functions for Computation and Plot of Cniper Contamination and Cniper Points.">
<param name="Local" value="cniperCont.html">
</OBJECT>
<LI> <OBJECT type="text/sitemap">
-<param name="Name" value="Methods for Function updateNorm in Package `ROptEst' ">
+<param name="Name" value="Methods for Function updateNorm in Package 'ROptEst'">
<param name="Local" value="updateNorm-methods.html">
</OBJECT>
<LI> <OBJECT type="text/sitemap">
-<param name="Name" value="Optimally robust estimation ">
-<param name="Local" value="roptest.html">
+<param name="Name" value="Optimally robust estimation">
+<param name="Local" value="0ROptEst-package.html">
</OBJECT>
</UL>
</UL>
Modified: branches/robast-0.7/pkg/ROptEst/chm/getInfRobIC.html
===================================================================
--- branches/robast-0.7/pkg/ROptEst/chm/getInfRobIC.html 2009-07-21 12:17:02 UTC (rev 329)
+++ branches/robast-0.7/pkg/ROptEst/chm/getInfRobIC.html 2009-07-31 12:05:04 UTC (rev 330)
@@ -64,12 +64,13 @@
## S4 method for signature 'UnivariateDistribution,
## asHampel, UncondNeighborhood':
getInfRobIC(L2deriv, risk, neighbor, symm, Finfo, trafo,
- upper, maxiter, tol, warn, noLow = FALSE, verbose = FALSE)
+ upper, maxiter, tol, warn, noLow = FALSE, verbose = FALSE, checkBounds = TRUE)
## S4 method for signature 'RealRandVariable, asHampel,
## ContNeighborhood':
getInfRobIC(L2deriv, risk, neighbor, Distr, DistrSymm, L2derivSymm,
- L2derivDistrSymm, Finfo, trafo, onesetLM = FALSE, z.start, A.start, upper, maxiter, tol, warn, verbose = FALSE)
[TRUNCATED]
To get the complete diff run:
svnlook diff /svnroot/robast -r 330
More information about the Robast-commits
mailing list