search for: x_0

Displaying 20 results from an estimated 24 matches for "x_0".

Did you mean: x00
2016 Jul 20
4
un solo un favor
...tar usando bien 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 'spTrans...
2010 Sep 08
11
problem with outer
...plot it: but i get this error message. i hope someone can help me. Error in dim(robj) <- c(dX, dY) : dims [product 16] do not match the length of object [1] p_11=seq(0,0.3,0.1) p_12=seq(0.1,0.4,0.1) guete = function(p_11,p_12) { set.seed(1000) S_vek=matrix(0,nrow=N,ncol=1) for(i in 1:N) { X_0=rmultinom(q-1,size=1,prob=p_0) X_1=rmultinom(n-q+1,size=1,prob=cbind(p_11,p_12,(1-p_11-p_12))) N_0=apply(X_0[,(n-2*k-L+1):(n-k-L)],1,sum) N_1=apply(X_1[,(n-q-k+2):(n-q+1)],1,sum) S_vek[i]=((sum(((N_1-k*cbind(p_11,p_12,(1-p_11-p_12)))^2)/k*cbind(p_11,p_12,(1-p_11-p_12))))/(sum(((N_0-k*p_0)^2)/k*p_0)...
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 <- cei...
2012 Oct 30
0
lapply and kernelUD (adehabitatHR package): Home Range kernel estimation for a list of individuals
...FOR ONE 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 (-72...
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.
2012 Jun 28
0
How to calculate Confidence Interval for a prediction using Partial Regression?
...(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. Right now, the on...
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 e...
2007 Sep 06
1
write geotiff with projection - RGDAL package
...displayed correctly. 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 i...
2014 Feb 08
0
[PATCH v2] arm: Use the UAL syntax for instructions
...E r12, r12, #1 + LDRHGT r8, [r5], #2 BGT celt_pitch_xcorr_edsp_process1u_loop1 ; Restore _x SUB r4, r4, r3, LSL #1 @@ -474,7 +474,7 @@ celt_pitch_xcorr_edsp_process2_1 ADDS r12, r12, #1 ; Stall SMLABB r10, r6, r8, r10 ; sum0 = MAC16_16(sum0, x_0, y_0) - LDRGTH r7, [r4], #2 + LDRHGT r7, [r4], #2 SMLABT r11, r6, r8, r11 ; sum1 = MAC16_16(sum1, x_0, y_1) BLE celt_pitch_xcorr_edsp_process2_done LDRH r9, [r5], #2 @@ -527,8 +527,8 @@ celt_pitch_xcorr_edsp_process1a_loop_done SUBGE r12, r12, #2...
2011 Oct 18
1
problem with project command in rgdal
...I can do 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...
2012 Sep 02
1
why variations in accuracy between R to ARCGIS for the same point reprojection?
...to ensure 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 calcul...
2014 Feb 07
3
[PATCH 1/2] arm: Use the UAL syntax for ldr<cc>h instructions
...H r8, [r5], #2 + LDRHGT r8, [r5], #2 BGT celt_pitch_xcorr_edsp_process1u_loop1 ; Restore _x SUB r4, r4, r3, LSL #1 @@ -474,7 +474,7 @@ celt_pitch_xcorr_edsp_process2_1 ADDS r12, r12, #1 ; Stall SMLABB r10, r6, r8, r10 ; sum0 = MAC16_16(sum0, x_0, y_0) - LDRGTH r7, [r4], #2 + LDRHGT r7, [r4], #2 SMLABT r11, r6, r8, r11 ; sum1 = MAC16_16(sum1, x_0, y_1) BLE celt_pitch_xcorr_edsp_process2_done LDRH r9, [r5], #2 @@ -527,8 +527,8 @@ celt_pitch_xcorr_edsp_process1a_loop_done SUBGE r12, r12, #2...
2003 Aug 16
2
Prediction Intervals (reposting)
(I'm reposting this message because the original has not appeared after about 2 days. Sorry if it shows up twice.) Hello. First, thanks to those who responded to my recent inquiry about using contour() over arbitrary (x,y) by mentioning the interp() function in the akima package. That worked nicely. Now for a new question: I would like to use a pair of prediction intervals to
2011 Jul 14
1
plotting x y z data from an irregular grid
...9.000000 5 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)...
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
2007 Jul 06
0
import DTM with readRAST6()
...complete: 100% r.out.bin 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.1...
2012 Feb 23
0
resistanceDistance representation
...into a new transition: > 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<-geoCorrecti...
2012 Apr 26
2
HoltWinters() fitted values
Hi everyone, I'm using the HoltWinters() function to do a time series analysis. The function only returns the back fitted values ($fitted) after the first year of data, which is my case, is a little more than half. However, when I use the plot() function, it plots the back fit for almost the entire data set. Any ideas on how to extract the fitted values going all the way back to the start
2017 Feb 05
3
Adding Extended-SSA to LLVM
...es = phi i32 [ %x, %cond_true ], [ %x, %cond_false ] ret i32 %res } You will get: ; CHECK-LABEL: @test12( ; CHECK-NEXT: [[CMP:%.*]] = icmp eq i32 [[X:%.*]], 0 ; CHECK-NEXT: br i1 [[CMP]], label [[COND_TRUE:%.*]], label [[COND_FALSE:%.*]] ; CHECK: cond_true: ; CHECK-NEXT: [[X_0:%.*]] = call i32 @llvm.ssa.copy.i32(i32 [[X]]) ; CHECK-NEXT: br label [[RET:%.*]] ; CHECK: cond_false: ; CHECK-NEXT: [[X_1:%.*]] = call i32 @llvm.ssa.copy.i32(i32 [[X]]) ; CHECK-NEXT: br label [[RET]] ; CHECK: ret: ; CHECK-NEXT: [[RES:%.*]] = phi i32 [ [[X_0]], [[COND_...
2012 Apr 01
4
map and shapefile help
Hi, I want to use map("state") and have the ecoregion shape (please see link) file projected onto this. ftp://ftp.epa.gov/wed/ecoregions/cec_na/NA_CEC_Eco_Level3.zip ftp://ftp.epa.gov/wed/ecoregions/cec_na/NA_CEC_Eco_Level3.zip Could someone please show me how; I have never messed with this sort of thing. Thanks. -- View this message in context: