search for: y_0

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

Did you mean: y0
2016 Jul 20
4
un solo un favor
...la funciĆ³n CRS ponendo bien los limites requeridos. > study_area <- readRDS("CHL_adm0.rds") > study_area_UTM <- spTransform(study_area, CRS("+proj=utm +zone=19 +datum=WGS84")) > study_area_UTM <- spTransform(study_area_UTM, CRS( + paste("+x_0=-2000000.0 +y_0=-500000.0 +ellps=GRS80 +units=us-ft +no_defs"))) Error in spTransform(study_area_UTM, CRS(paste("+x_0=-2000000.0 +y_0=-500000.0 +ellps=GRS80 +units=us-ft +no_defs"))) : error in evaluating the argument 'CRSobj' in selecting a method for function 'spTransform': Error...
2011 Jan 05
1
Prediction error for Ordinary Kriging
Hi ALL, Can you please help me on how to determine the prediction error for ordinary kriging?Below are all the commands i used to generate the OK plot: rsa2 <- readShapeSpatial("residentialsa", CRS("+proj=tmerc +lat_0=39.66666666666666 +lon_0=-8.131906111111112 +k=1 +x_0=0 +y_0=0 +ellps=intl +units=m +no_defs")) x2 <- readShapeSpatial("ptna2", CRS("+proj=tmerc +lat_0=39.66666666666666 +lon_0=-8.131906111111112 +k=1 +x_0=0 +y_0=0 +ellps=intl +units=m +no_defs")) bb <- bbox(rsa2) cs <- c(1, 1) cc <- bb[, 1] + (cs/2) cd <- ceiling(di...
2018 Apr 18
2
Event-triggered change in value with a time-delay
...ther by increasing or decreasing), there is a time delay (delay) before the parameter shifts values. ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ Toy model: # define parameters P <- c(m = 10, R_1 = 0.5, R_2 = 0.1, D_0 = 50, D_T = 5, delay = 3 ) # set initial values y_0 <- c(D = 0, Y = 1) # set timesteps times <- seq(0, 100, length = 101) # define function bit <- function(t,y,parms){ with(as.list(c(parms,y)),{ # How I would implement the change if there was no time delay # m <- ifelse(D>=D_T, m*.68, m) # Option 1: nested if statem...
2012 Jun 28
0
How to calculate Confidence Interval for a prediction using Partial Regression?
...residuals (e_y) (reg1) - I regressed x to A, and calculated the residuals (e_x) (reg2) - I regressed e_y to e_x (reg5) It looks like this: y = a_0 + a_1 A (reg1) x = b_0 + b_1 A (reg2) e_y = y - (a_0 + a_1 A) (3) e_x = x - (b_0 + b_1 A) (4) e_y = beta_0 + beta_1 e_x (reg5) Then, to predict a y_0 from a new x_0 and A_0, we would: Calculate e_x0 with the equation (4). Calculate e_y0 with the equation (reg5) and then: y_0 = e_y0 + (a_0 + a_1 A_0) Now, I would like to know how different in Area (A) must be two new observations with the same x_0 value to have different predicted y_0 values. Ri...
2012 Oct 30
0
lapply and kernelUD (adehabitatHR package): Home Range kernel estimation for a list of individuals
...ANIMAL NAMED "Gael". IT WORKED PERFECTLY! ># Read a shapefile and convert it into a SpatialPointsDataFrame with its corresponding CRS >Gael_WGS84_WorldM <- readShapePoints("900_Gael_WGS84_WorldM", proj4string=CRS("+proj=merc +lon_0=0 +k=1 +x_0=0 +y_0=0 +ellps=WGS84 +datum=WGS84 +units=m +no_defs")) ># Remove all the columns except the name of the animal to use the kernelUD function. My data looks like this: > head(Gael_WGS84_WorldM[-c(2:25)]) coordinates Name 0 (-683614, 4459280) Gael 1 (-769563, 4516660) Gael 2 (-721607, 4...
2018 Apr 18
0
Event-triggered change in value with a time-delay
...threshold without blowing up. -- David. > ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ > Toy model: > # define parameters > P <- c(m = 10, > R_1 = 0.5, > R_2 = 0.1, > D_0 = 50, > D_T = 5, > delay = 3 > ) > # set initial values > y_0 <- c(D = 0, Y = 1) > > # set timesteps > times <- seq(0, 100, length = 101) > > # define function > bit <- function(t,y,parms){ > with(as.list(c(parms,y)),{ > > > # How I would implement the change if there was no time delay > # m <- ifelse(D&...
2014 Feb 08
3
[PATCH 1/2] arm: Use the UAL syntax for ldr<cc>h instructions
On Fri, 7 Feb 2014, Timothy B. Terriberry wrote: > Martin Storsjo wrote: >> This is required in order to build using the built-in assembler >> in clang. > > These patches break the gcc build (with "Error: bad instruction"). Ah, right, sorry about that. > Documentation I've seen is contradictory on which order ({cond}{size} or > {size}{cond}) is correct.
2003 Nov 10
1
ts package function filter: mismatch between function action and help (PR#5017)
...sides = 2, circular = FALSE, init) # init: for recursive filters only. Specifies the initial values of # the time series just prior to the start value, in reverse # time order. The default is a set of zeros. but looks as if it should be in usual order as x is e.g. init y_0 y_-1 y_-2: 3, 2, 1 filter f_1 f_2 f_3: 1, .5, .25 x: 4, 5, 6, 7, 8 y_1 = 4 + 1*3 + .5*2 + .25*1 = 8.25 y_2 = 5 + 1*8.25 + .5*3 + .25*2 = 15.25 ... but > filter(4:8,c(1,.5,.25),method="recursive", init=3:1) Time Series: Start = 1 End = 5 Frequency = 1 [1] 6.7500 12.7500 22.3750 37....
2007 Jan 17
1
sp: proj4string has no impact
Hi all, I'm faced with a problem applying the sp package: The projection argument in readShapePoly(Shapefile,proj4string="CRS class argument") e.g.: CRS("+proj=aea +lat_1=46 +lat_2=73 +lat_0=60 +lon_0=84 +x_0=0 +y_0=0 +ellps=clrk66 +units=m +no_defs") doesn't have any impact on the plotted object. I also tested the simple example: xy = cbind(x = 2 * runif(100) - 1, y = 2 * runif(100) - 1) plot(SpatialPoints(xy, proj4string = CRS("+proj=longlat")),xlim=c(-1,1),ylim=c(-1,1)) looks exactly...
2007 Sep 06
1
write geotiff with projection - RGDAL package
.... I guess somewhere i am doing a mistake when i define the projection in R. My code follows: data.grid <- read.csv(x, header=TRUE) gridded(data.grid) = ~East.m.+North.m. proj4string(data.grid) = CRS("+proj=tmerc +lat_0=0.00000000000 +lon_0=-81.00000000000 +k=0.99960000 +x_0=500000.000000 +y_0=0.0000000 +ellps=GRS80 +units=m") tr <- "e:\\JELA_veg\\test_gtiff\\test.tif" writeGDAL(data.grid["class.pca"], tr) mg3 <- readGDAL(tr) proj4string(mg3) [1] " +proj=utm +zone=17 +ellps=GRS80 +units=m +no_defs" I will really appreciate if anybody can point...
2014 Feb 08
0
[PATCH v2] arm: Use the UAL syntax for instructions
...rm/celt_pitch_xcorr_arm.s index 09917b1..598e45b 100644 --- a/celt/arm/celt_pitch_xcorr_arm.s +++ b/celt/arm/celt_pitch_xcorr_arm.s @@ -309,7 +309,7 @@ xcorr_kernel_edsp_process4_done SUBS r2, r2, #1 ; j-- ; Stall SMLABB r6, r12, r10, r6 ; sum[0] = MAC16_16(sum[0],x,y_0) - LDRGTH r14, [r4], #2 ; r14 = *x++ + LDRHGT r14, [r4], #2 ; r14 = *x++ SMLABT r7, r12, r10, r7 ; sum[1] = MAC16_16(sum[1],x,y_1) SMLABB r8, r12, r11, r8 ; sum[2] = MAC16_16(sum[2],x,y_2) SMLABT r9, r12, r11, r9 ; sum[3] = MAC16_16(sum[3],x,...
2011 Oct 18
1
problem with project command in rgdal
...o the analysis. I've been trying to use the project command in rgdal but keep getting an error message saying: Error in project(locationsMatrix, PROJECTION.OUT) : latitude or longitude exceeded limits ( PROJECTION.OUT <- "+proj=aea +lat_1=-18 +lat_2=-36 +lat_0=0 +lon_0=132 +x_0=0 +y_0=0 +ellps=GRS80 +towgs84=0,0,0,0,0,0,0 +units=m +no_defs") I know that I'm using the right proj4 format (got it from the espy file in the Proj4 data directory) and I know that the datum is correct as I often use it in GIS (GDA94; Australia Albers). Before using the project command I have...
2012 Sep 02
1
why variations in accuracy between R to ARCGIS for the same point reprojection?
...ure equal area distribution of the points. In R, I am using: spPoint <- SpatialPoints(coords=coordinates(Data),proj4string=CRS("+proj=longlat +datum=WGS84")) and then reprojecting it to Berhmann with: spPointReprj=spTransform(Data,CRS("+proj=cea +lon_0=0 +lat_ts=30 +x_0=0 +y_0=0 +ellps=WGS84")) If I put the two outputs of the reprojections in the same map, they are off by few meters in the tropics by up to 40km in the poles. I decided to investigate how the reprojections are done and my calculations are different from both R and ArcGis: First, I calculated th...
2014 Feb 07
3
[PATCH 1/2] arm: Use the UAL syntax for ldr<cc>h instructions
...rm/celt_pitch_xcorr_arm.s index 09917b1..3c4b950 100644 --- a/celt/arm/celt_pitch_xcorr_arm.s +++ b/celt/arm/celt_pitch_xcorr_arm.s @@ -309,7 +309,7 @@ xcorr_kernel_edsp_process4_done SUBS r2, r2, #1 ; j-- ; Stall SMLABB r6, r12, r10, r6 ; sum[0] = MAC16_16(sum[0],x,y_0) - LDRGTH r14, [r4], #2 ; r14 = *x++ + LDRHGT r14, [r4], #2 ; r14 = *x++ SMLABT r7, r12, r10, r7 ; sum[1] = MAC16_16(sum[1],x,y_1) SMLABB r8, r12, r11, r8 ; sum[2] = MAC16_16(sum[2],x,y_2) SMLABT r9, r12, r11, r9 ; sum[3] = MAC16_16(sum[3],x,...
2011 Jul 14
1
plotting x y z data from an irregular grid
...0.3431518 -999.000000 6 -0.7966338 -2.144316 #read in the shapefile england<-readShapePoly('D:/arcGIS/england boundary/england.shp') class(england) #define the projection proj4string(england)<-CRS('+proj=tmerc +lat_0=49 +lon_0=-2 +k=0.999601271625 +x_0=400000 +y_0=-100000 +ellps=airy +units=m +no_defs') # transform the map into the WGS84 projection (epsg:4326): england.wgs<-spTransform(england, CRS('+init=epsg:4326')) plot(england.wgs) #plot data over the map: quilt.plot(data$Longitude, data$Latitude, data$perc_per_year, add=TRUE) My problem...
2009 Nov 06
4
map of a country and its different geographical levels
Hi R users I need the map of France?s ? communes ? (towns) to build a map Is there a way to get it? More generally: How to do to get the map of a country and its different geographical levels? Best regards -- View this message in context: http://old.nabble.com/map-of-a-country-and-its-different-geographical-levels-tp26225645p26225645.html Sent from the R help mailing list archive at
2011 Dec 01
1
Estimation of AR(1) Model with Markov Switching
...ate <- rep(0,100) # choose initial state at t=0 to be state 0 gamma[1] <- gamma_s0 state[1] <- 0 for(i in 2:100) { if(rnorm(1) < gamma[i-1]) { gamma[i] <- gamma_s0 state[i] <- 0 } else { gamma[i] <- gamma_s1 state[i] <- 1 } } # generate observations # choose y_0 = 0 # recall state at t=1 was set to 0 y1 <- 2 + 0.5 * 0 + rnorm(1) y <- rep(0,100) y[1] <- y1 for(i in 2:100) { if(state[i]==0) { y[i] <- 2 + 0.5 * y[i-1] + rnorm(1) } else { y[i] <- 0.5 + 0.9 * y[i-1] + rnorm(1) } } # convert into time series object y <- ts(y...
2007 Jul 06
0
import DTM with readRAST6()
...n complete. > summary(trentino.grid) Object of class SpatialGridDataFrame Coordinates: min max coords.x1 1611600 1729700 coords.x2 5058500 5158000 Is projected: TRUE proj4string : [+proj=tmerc +lat_0=0.0000000000 +lon_0=9.0000000000 +k_0=0.9996000000 +x_0=1500000.0000000000 +y_0=0.0000000000 +a=6378388 +rf=297 +no_defs +towgs84=-225.000,-65.000,9.000] Number of points: 2 Grid attributes: cellcentre.offset cellsize cells.dim 1 1611650 100 1181 2 5058550 100 995 Data attributes: DTM_trentino_100m Min. :1.192e-319 1st Qu.:1.065e-3...
2008 Mar 26
0
recursive multivariate filter with time-varying coefficients
Hi, I've been searching CRAN and the web for a recursive multivariate filter with time-varying coefficients. What I mean is the following: I have a series of square matrices A_t an initial value vector y_0 and I need to compute y_t =A_t%*%y_t-1 As these y_t may diverge quickly and/or lead to underflow problems, the y_t need to be scaled by eg y_t =y_t/sum(y_t-1) Is anyone aware whether this has been implemented somewhere? Best, Ingmar
2012 Feb 23
0
resistanceDistance representation
...ransition: > MY_transitionclass : TransitionLayer dimensions : 2181, 1648, 3594288 (nrow, ncol, ncell) resolution : 100.0049, 99.98945 (x, y) extent : 1460708, 1625516, 4947383, 5165460 (xmin, xmax, ymin, ymax) coord. ref. : +proj=tmerc +lat_0=0 +lon_0=9 +k=0.9996 +x_0=1500000 +y_0=0 +ellps=intl +towgs84=-225,-65,9,0,0,0,0 +units=m +no_defs values : conductance matrix class: dsCMatrix I applied two different geocorrections to this same transition: > MY_correction<-geoCorrection(MY_transition,"c",F,scl=T) > MY_Rcorrection<-geoCorrection(MY_transit...