search for: delta1

Displaying 20 results from an estimated 23 matches for "delta1".

Did you mean: delta
2009 Nov 20
3
symbol in the plot
a graph question. Thanks a lot in advance. I made two scatterplots on one graph (sigma vs. delta1, sigma vs. delta2) (20 observations of delta1, delta2 and corresponding sigma) the x-axis is sigma, the y-axis is either delta1 or delta2. I connected both scatterplots. To seperate them, one curves is a line with circles, the other curve is a line with squares on it. I want to make a notation ei...
2006 Jun 19
2
Nested variance-covariance matrix in Multilevel model
...0 0 V3 where V1...V3 are of the structure: v11 v12 V1= and so on. v21 v22 V1...V3 are assumed to have a compound symmetric variance-covariance structure and therefore the submatrices are of the form: Lambda Delta1 Delta1 ... Delta1 Delta1 Lambda Delta1 ... Delta1 v11=v22= ....... Delta1 ..... Lambda Delta2 Delta2 Delta2 ... Delta2 Delta2 Delta2...
2013 Feb 18
2
error: Error in if (is.na(f0$objective)) { : argument is of length zero
...t;-solve(I-H) one <- matrix(1,nrow=t,ncol=1) u <- matrix(0,nrow=m,ncol=1) y<-c(u, 1, u) z<-t(y) ARLV<-K%*%one ARLV2<-t(ARLV) return((ARLV2%*%y)/3) } # constraint function eval_g0 <- function(x) {m1<-100 t1<-2*m1+1 H1<-matrix(data=NA,nrow=t1,ncol=t1) I1<-diag(t1) delta1<-2*x[1]/t1 z1<--x[1]+.5*delta1 range11<-t1 for (i1 in 1:range11){ z_i1=-x[1]+(i1-.5)*delta1 for (j1 in 1:range11){ up1<-((-x[1]+j1*delta1-(1-x[2])*z_i1)/x[2]) down1<-((-x[1]+(j1-1)*delta1-(1-x[2])*z_i1)/x[2]) H1[i1,j1]<-pnorm(up1,mean=5,sd...
2005 Nov 17
3
loess: choose span to minimize AIC?
...t for a specified criterion. loess.aic <- function (x) { # extract values from loess object if (!(inherits(x,"loess"))) stop("Error: argument must be a loess object") span <- x$pars$span n <- x$n traceL <- x$trace.hat sigma2 <- sum( x$residuals^2 ) / (n-1) delta1 <- x$one.delta delta2 <- x$two.delta enp <- x$enp aicc <- log(sigma2) + 1 + 2* (2*(traceL+1)) / (n-traceL-2) aicc1<- n*log(sigma2) + n* ( (delta1/(delta2*(n+enp)))/(delta1^2/delta2)-2 ) gcv <- n*sigma2 / (n-traceL)^2 result <- list(span=span, aicc=aicc, aicc1=aicc1,...
2013 Jan 03
0
help with NLOPTR
...s ("mosaic") library(mosaic) ###### Global Parameters ############ beeta=0.8 pq=10000 pf=10000 F=20 L=12600 theta=0.6 psale=0.6 mu=psale*(1-theta) alphah=0.15 Cg=6240 Cs=2820 A= 100 D=0.0001 greekp=0.43 K=100000 ##### Species Parameters########## b1=0.38 p1=16654 v1 = 0.28 N1=6000 g1=1 delta1=1 b2=0.4 p2=2797 v2 = 0.31 N2=10000 g2=1 delta2=1 ####################################### Objective function ############################################ eval_f = function (x) { return(-1 * ( ( (1-alphah) *log(F) ) + ( alphah* ( (x[1]*(((N1/A)*(g1^greekp)*(x[3]^b1))+((1-exp(-2*D*v1*N1))*x[4]...
2010 Mar 16
0
recursive term
Hi r-users;   I have this values: eign_val <- c(137.810447,3.538721,2.995161,1.685670) alp    <- 1.6549 ;  lamda <- eign_val lamda_m <- min(lamda)   First I calculated manually: delta0 <- 1 delta1 <- alp*delta0*(4-lamda_m*(1/lamda[1]+1/lamda[2]+1/lamda[3]+1/lamda[4]))  delta1 delta2 <- (alp/2)*(delta1*(delta1/alp) + delta0*((1-lamda_m/lamda[1])^2+ (1-lamda_m/lamda[2])^2+(1-lamda_m/lamda[3])^2+(1-lamda_m/lamda[4])^2)) delta2 delta3 <- (alp/3)*(delta2*(delta1/alp) + delta1*((1-lamda_...
2006 Jul 22
1
Why the contrain does not work for selecting a particular range of data?
...for maximizing likelihood. I used two way to do this but the results are different. 1.Way one I use the data for x2=1 and run the program. It works for me. Tthe program is described as below: function (parameters,y1,x11) { p<-parameters[1] alpha1<-parameters[2] beta1<-parameters[3] delta1<-parameters[4] lamda1<-parameters[5] mu<-alpha1*((x11)^beta1)*exp(-delta1*(x11^lamda1)) ifelse(y1>0|x11>0, L<-lgamma(y1+p)+p*(log(p)-log(mu+p))+y1*(log(mu)-log(mu+p))-lfactorial(y1)-lgamma(p) ,Inf) L } This is working for me. 2 Way two: I select the data whose x2=1...
2006 Dec 14
3
Model formula question
Hi all, I'm not familiar with R programming and I'm trying to reproduce a result from a paper. Basically, I have a dataset which I would like to model in terms of successive increments, i.e. (y denote empirical values of y) y_1 = y1, y_2 = y1 + delta1, y_3 = y1 + delta1 + delta2. ... y_m = y1 + sum_2^m delta j where delta_j donote successive increments in the y-values, i.e. delta j = y_j - y_(j-1). In order to estimate y-values, I'm assuming that delta j is approximately equal to kj**u, such that my regression model should be something...
2006 Jul 22
1
ifelse command
...elihood function below using something constrains. But it seems something wrong with it. Becasue R would not allow me to edit the function like this. It is very appreciate if you can help. function (parameters,y,x1,x2) { p<-parameters[1] alpha1<-parameters[2] beta1<-parameters[3)] delta1<-parameters[4] alpha2<-parameters[5] mu<-alpha1*((x1)^beta1)*exp(-delta1*(x1^alpha2)) if(y>0 & x1>0 & x2==1, L<-lgamma(y+p)+p*(log(p)-log(mu+p))+y*(log(mu)-log(mu+p))-lfactorial(y)-lgamma(p) ) else if(y>0 & x1>0 & x2==2, L<-lgamma(y+p)+p*(log(p)-lo...
2002 Mar 12
1
Sparse matrix methods
Does anyone know of contributions to R for solving sparse linear systems? In particular for spatial stats I am interested in solving large positive definite symmetric systems. Thanks in advance, Doug ----------------------------------------------------------------------------- Doug Nychka, Geophysical Statistics Project Email: nychka at ucar.edu National Center for Atmospheric
2012 Dec 04
1
Solve system of equations (nleqslv) only returns origin
...uments/R.Codes/R.Packages/") require(nleqslv) ###### Global Parameters ############ beeta=0.8 pq=10000 L=12600 theta=0.6 psale=0.6 mu=psale*(1-theta) alphah=0.15 Cg=6240 Cs=2820 A= 100 D=0.0001 greekp=0.43 K=100000 ##### Species Parameters ########## b1=0.38 p1=16654 v1 = 0.28 N1=6000 g1=1 delta1=1 b2=0.4 p2=2797 v2 = 0.31 N2=10000 g2=1 delta2=1 ### Define functions with vector x = c(Lg, Ls, gamma1, gamma2, lamda) firstordercond <- function (x) { y=numeric(4) y[1]=(alphah/x[3])-(x[5]*((p1-(((theta+mu)*(((N1/A)*g1^greekp*x[1]^b1)+K))+((theta+mu)*(((1-exp(-2*D*v1*N1))*x[2])+K))))...
2010 May 18
1
proportion of treatment effect by a surrogate (fitting multivariate survival model)
...a (Wei, Lin, and Weissfeld 1989 JASA), and is implemented in Lin's MULCOX2, SAS, and S-plus. Is this the way to fit such a model in R? Suppose I have variables: time, delta, treatment, and surrogate. Should I repeat the dataset (2x) and stack, creating the variables: time1 (time repeated 2x), delta1 (delta repeated 2x), treatment1 (same as treatment, but 0's for the 2nd set), treatment2 (0's in first set, then same as treatment), and surrogate2 (0's in first set, then same as treatment), and id (label the subject, so each id should have 2 observations). Thus, a dataset with n obse...
2006 Jun 14
2
Bug or not? (PR#8977)
This is an OpenPGP/MIME signed message (RFC 2440 and 3156) --------------enig807B2312A20EAF60129FDDFA Content-Type: text/plain; charset=ISO-8859-1 Content-Transfer-Encoding: quoted-printable Hi, I am writing this email, because I am not sure if the issue I have discovered is a bug or not. For a few days I have been fiddling around with a small program that calculates the reflectance of
2006 May 16
1
r-help@stat.math.ethz.ch
Dear All: I tried to fit negative binomial distribution to data in terms of mean and mean is also a quadratic function of another variable. The likelihood function is: function (parameters, y1,x11) { p<-parameters[1] alpha1<-parameters[1] beta1<-parameters[2] delta1<-parameters[3] mu<-alpha1+beta1*(x11)+delta1*(x11^2) ifelse(y1>=0|x11>=0, L<- lgamma(y1+p)+p*(log(p)-log(mu+p))+y1*(log(mu)-log(mu+p)) -lfactorial(y1)-lgamma(p) ,Inf) L } I got outputs even it sounds a problem for delata. Actually, there is a...
2005 Jan 13
1
upgrading (?) from 2.2.4 to 3.0.8pre1-0.pre1.3
...that we use samba to share to the rest of the network. 2.2.4 works great, 3.0 doesn't using the same smb.conf. I'm sure there are some things that have changed but even trying to take the examples on the site and mod them to fit my case doesn't work either. The linux/samba box name is delta1, just browsing to \\delta1 gives me the name/pass prompt. Before entering my name/pass I go check the samba log file for the machine I am browsing from and It has: [2005/01/13 02:41:48, 0] auth/auth_util.c:make_server_info_info3(1122) make_server_info_info3: pdb_init_sam failed! [2005/01/13 02:...
2006 Dec 14
0
Model formula
...question To: r-help at stat.math.ethz.ch Hi all, I'm not familiar with R programming and I'm trying to reproduce a result from a paper. Basically, I have a dataset which I would like to model in terms of successive increments, i.e. (y denote empirical values of y) y_1 = y1, y_2 = y1 + delta1, y_3 = y1 + delta1 + delta2. ... y_m = y1 + sum_2^m delta j where delta_j donote successive increments in the y-values, i.e. delta j = y_j - y_(j-1). In order to estimate y-values, I'm assuming that delta j is approximately equal to kj**u, such that my regression model should be something...
2011 May 12
1
Maximization of a loglikelihood function with double sums
...with experience in maximization could tell me if a function like that could be maximized using R and if s/he could point me to a package which might be useful for that. Just to give you some more details on the loglikelihood function attached: * Data vectors:u, zr, s * Indicator variables: epsilon, delta1, delta2 * Matrix with indicator variables: alpha * Unknown parameters: mu, beta, sigma * Unknown parameter vector: omega (contains probabilities). I'd be very grateful for any helpful information. Klaus. -- ---------------------------------------------------- Klaus Langohr Departament d...
2017 May 18
3
Memory accesses and determining aliasing at the MI level
In order to implement a subtle memory access optimisation during post-RA scheduling, I want to be able to determine some properties about the memory access. If I have two registers referring to memory, how can I determine if they are derived from the same base-pointer? Often LLVM will optimise to use intermediate registers holding partial displacements, for example, when a 'struct'
2011 Jun 16
0
Update: Is there an implementation of loess with more than 3 parametric predictors or a trick to a similar effect?
...eger(order.drop.sqr), as.integer(sum.drop.sqr), as.double(span*cell), as.character(surf.stat), fitted.values = double(N), parameter = integer(7), a = integer(max.kd), xi = double(max.kd), vert = double(2*D), vval = double((D+1)*max.kd), diagonal = double(N), trL = double(1), delta1 = double(1), delta2 = double(1), as.integer(surf.stat == "interpolate/exact")) if(j==1) { trace.hat.out <- z$trL one.delta <- z$delta1 two.delta <- z$delta2 } fitted.residuals <- y - z$fitted.values if(j < iterations) robust <- .Fortran(R_lowe...
2008 Jan 06
1
overheating Thinkpad X60s with 7.0-RC1
Hello everybody! Since the update from 6.2-STABLE to 7.0 I'm encountering problems with the temperature of my Thinkpad X60s. Under heavy load, e.g., make builworld or compile gcc or... I get the following output in /var/log/messages: Dec 29 01:53:13 delta1 root: WARNING: system temperature too high, shutting down soon! Dec 29 01:53:13 delta1 syslogd: /dev/:0: No such file or directory Dec 29 01:53:23 delta1 kernel: acpi_tz0: WARNING - current temperature ( 128.0C) exceeds safe limits Dec 29 01:53:24 delta1 syslogd: exiting on signal 15 So far so bad...