Tahapan Pengestimasian Direct dan Traditional Indirect Estimation:

  1. Data Preparation
library(readxl)
Jatim_pengeluaran <- read_excel("D:/Kuliah/tkt IV/The Journey Start/SAE/Data SAE/Jatim_pengeluaran.xlsx", 
                                col_types = c("text", "text", "numeric", 
                                              "text", "text", "numeric", "numeric", 
                                              "numeric", "numeric"))
Xnew_ya <- read_excel("D:/Kuliah/tkt IV/The Journey Start/SAE/Data SAE/Xnew ya.xlsx", 
                      sheet = "Sheet2", col_types = c("text", "text", "text", "text", "text", "text", 
                                                      "numeric", "numeric", "numeric", "numeric", "numeric", "numeric", 
                                                      "numeric", "numeric", "numeric", "numeric", "numeric", "numeric", 
                                                      "numeric", "numeric", "numeric", "numeric", "numeric", "numeric", 
                                                      "numeric", "numeric", "numeric", "numeric", "numeric", "numeric", 
                                                      "numeric", "numeric", "numeric", "numeric", "numeric", "numeric", 
                                                      "numeric", "numeric", "numeric", "numeric", "numeric"))

muatan <- read_excel("D:/Kuliah/tkt IV/The Journey Start/SAE/Data SAE/muatan.xlsx", 
                     sheet = "Sheet3", col_types = c("text","text", "numeric"))

#variabel_X_signifikan
x1 <- aggregate(Xnew_ya$X1, list(Xnew_ya$R102),sum,na.rm=TRUE)
x12 <- aggregate(Xnew_ya$X12, list(Xnew_ya$R102),sum,na.rm=TRUE)
x13 <- aggregate(Xnew_ya$X13, list(Xnew_ya$R102),sum,na.rm=TRUE)
x20 <- aggregate(Xnew_ya$X20, list(Xnew_ya$R102),sum,na.rm=TRUE)
x27 <- aggregate(Xnew_ya$X27, list(Xnew_ya$R102),sum,na.rm=TRUE)
x31 <- aggregate(Xnew_ya$X31, list(Xnew_ya$R102),sum,na.rm=TRUE)

dt1 <- data.frame(cbind("bs_o"=Jatim_pengeluaran$`No Kode Sampel`,"pop"=Jatim_pengeluaran$Exp_krb,"kab"=Jatim_pengeluaran$R102))
mat_x <- matrix(cbind(1,x1$x,x12$x,x13$x,x20$x,x27$x,x31$x),ncol=7)

#Jumlah ruta tiap kab (Ni)
ht_rt <- function(dt1){
  r102 = unique(dt1$kab)
  de = data.frame(r102)
  Peng_jatim <- data.frame(dt1)
  ds <- list() 
  for (i in r102){
    ds[[i]] <- subset(Peng_jatim, kab %in% i)
  }
  Ni <- c()
  for(k in r102){
    Ni[k] <- length(ds[[k]]$kab)
  }
  N_desa <- data.frame("desa"=Ni)
  return(N_desa)
}
Ni_ruta <- ht_rt(dt1)
  1. Fungsi Estimasi untuk metode SRS

    1. Menggunakan rumus MSE synthetic yang awal
resampling_srs = function(data, dataX, proporsi,iterasi ){
  myDataY = data
  prop = proporsi
  propinsi <- function(data, prop){  
    srs_sampling <- function(data, prop){
      kab_1= data
      samp_rt <- sample(1:length(kab_1$pop), size = prop*length(kab_1$pop), replace = FALSE)
      hs_samp_srs <-  kab_1[samp_rt,]
      hs_samp_srs$pop <- as.numeric(paste(hs_samp_srs$pop))
      hs_samp_srs <- data.frame(hs_samp_srs)
      est_ybar_srs <- function(data,f){
        hs_samp_srs <- data
        y_tot_samp <- sum(hs_samp_srs$pop)
        n <- length(hs_samp_srs$pop)
        y_bar <- y_tot_samp/n
        Y_cap_est <- n/f*y_bar
        s_kw <- sum((hs_samp_srs$pop - (matrix(y_bar,ncol = 1)))^2)/(n-1)
        var_y_bar <- (1-f)*s_kw/n
        Var_cap_est <- (n/f)^2*var_y_bar
        rel_var_y <- Var_cap_est/Y_cap_est
        hasil <- cbind(Y_cap_est,Var_cap_est,rel_var_y)
        return(hasil)
      }
      result = est_ybar_srs(hs_samp_srs, prop)
      
    }
    
    r102 = unique(dt1$kab)
    datakoeh = list()
    for(b in r102){
      datakoeh[[b]] <- subset(dt1, kab %in% b)
    }
    
    try_ye <- list()
    for(c in r102){
      try_ye[[c]] <- srs_sampling(data = datakoeh[[c]], prop = prop)  
    }
    
    this_it = data.frame()
    for (q in r102) {
      this_it <- rbind(this_it, try_ye[[q]])
    }
    this_it = cbind(r102, this_it)
  }  
  #fungsi estimasi synthetic dan composite
  Y_synth_comp <- function(x,y,vary){
    #synthetic function
    xty <- t(x)%*%y
    xtx <- t(x)%*%x
    bt_xy <- solve(xtx)%*%xty
    bt_xy = t(bt_xy)
    Y_syn <- c(rep(0,nrow(x)))
    for(i in 1: ncol(x)){
      Y_syn = Y_syn + x[,i]*bt_xy[,i]
    }
    Y_syn <- as.data.frame(Y_syn)
    mse_syn <- ((Y_syn-y)^2)-vary
    rel_mse_syn <- mse_syn/Y_syn
    #composite function
    tetha_i <- mse_syn/(vary+mse_syn)
    tetha_i[tetha_i<0]<-0
    tetha_i[tetha_i>1]<-1
    Y_comp <- (tetha_i*y) + ((1-tetha_i)*Y_syn)
    mse_comp <- (1-tetha_i)*mse_syn
    rel_mse_comp <- mse_comp/Y_comp
    Syn_Comp <- data.frame(cbind(Y_syn, Y_comp,mse_syn,  mse_comp, rel_mse_syn, rel_mse_comp))
    colnames(Syn_Comp) = c("Y syn","Y comp", "MSE syn",  "MSE comp", "Relatif MSE syn","Relatif MSE comp")
    return(Syn_Comp)
  }
  
  dataset = list()
  est_dataset = list()
  for( j in 1:iterasi){
    set.seed(j)
    dataset[[j]] = propinsi(myDataY, prop)
    est_dataset [[j]] = Y_synth_comp(dataX,dataset[[j]]$Y_cap_est,dataset[[j]]$Var_cap_est)
  }
  
  databind = data.frame()
  databind_ind = data.frame()
  for (b in 1:iterasi) {
    databind = rbind(databind, dataset[[b]])
    databind_ind = rbind(databind_ind, est_dataset[[b]])
  }
  
  datafinal = aggregate(list(databind$Y_cap_est,databind_ind$`Y syn`,databind_ind$`Y comp`,
                             databind$Var_cap_est,databind_ind$`MSE syn`,databind_ind$`MSE comp`
                             ,databind$rel_var_y,databind_ind$`Relatif MSE syn`,databind_ind$`Relatif MSE comp`),
                        by=list(databind$r102),
                        FUN=mean)
  colnames(datafinal) = c("kab", "Y dir", "Y syn","Y com", "MSE dir","MSE syn","MSE com",
                          "Relatif MSE dir","Relatif MSE syn","Relatif MSE com")
  datafinal$Efisiensi_syn <- datafinal$`MSE syn`/datafinal$`MSE dir`
  datafinal$Efisiensi_com <- datafinal$`MSE com`/datafinal$`MSE dir`
  return(datafinal)
}
b. Menggunakan rumus MSE synthetic yang perbaikan
resampling_srs_2 <- function(data, dataX, Ni, proporsi,iterasi ){
  myDataY <- data
  prop <- proporsi
  propinsi <- function(data, prop){  
    srs_sampling <- function(data, prop){
      kab_1= data
      samp_rt <- sample(1:length(kab_1$pop), size = prop*length(kab_1$pop), replace = FALSE)
      hs_samp_srs <-  kab_1[samp_rt,]
      hs_samp_srs$pop <- as.numeric(paste(hs_samp_srs$pop))
      hs_samp_srs <- data.frame(hs_samp_srs)
      est_ybar_srs <- function(data,f){
        hs_samp_srs <- data
        y_tot_samp <- sum(hs_samp_srs$pop)
        n <- length(hs_samp_srs$pop)
        y_bar <- y_tot_samp/n
        Y_cap_est <- n/f*y_bar
        s_kw <- sum((hs_samp_srs$pop - (matrix(y_bar,ncol = 1)))^2)/(n-1)
        var_y_bar <- (1-f)*s_kw/n
        Var_cap_est <- (n/f)^2*var_y_bar
        rel_var_y <- Var_cap_est/Y_cap_est
        hasil <- cbind(Y_cap_est,Var_cap_est,rel_var_y)
        return(hasil)
      }
      result = est_ybar_srs(hs_samp_srs, prop)
      
    }
    
    r102 = unique(dt1$kab)
    datakoeh = list()
    for(b in r102){
      datakoeh[[b]] <- subset(dt1, kab %in% b)
    }
    
    try_ye <- list()
    for(c in r102){
      try_ye[[c]] <- srs_sampling(data = datakoeh[[c]], prop = prop)  
    }
    
    this_it = data.frame()
    for (q in r102) {
      this_it <- rbind(this_it, try_ye[[q]])
    }
    this_it = cbind(r102, this_it)
  }
  
  #fungsi estimasi synthetic dan composite
  Y_synth_comp <- function(x,y,vary,Ni){
    #synthetic function
    N <- Ni
    xty <- t(x)%*%y
    xtx <- t(x)%*%x
    bt_xy <- solve(xtx)%*%xty
    bt_xy = t(bt_xy)
    Y_syn <- c(rep(0,nrow(x)))
    for(i in 1: ncol(x)){
      Y_syn = Y_syn + x[,i]*bt_xy[,i]
    }
    m <- length(Y_syn)
    Y_syn <- as.data.frame(Y_syn)
    mse <- sum((y - Y_syn)^2)/m-2
    var_y_cap_is <- c(rep(mse,m))
    Ni_2 <- N^2
    ba.1 <- (sum((Y_syn-y)^2/Ni_2))/m
    ba.2 <- (sum(rep(var(Y_syn-y),m)/Ni_2))/m
    ba_a <- ba.1 - ba.2 
    mse_syn <- var_y_cap_is + (Ni_2*ba_a)
    rel_mse_syn <- mse_syn/Y_syn
    #composite function
    tetha_i <- mse_syn/(vary+mse_syn)
    tetha_i[tetha_i<0]<-0
    tetha_i[tetha_i>1]<-1
    Y_comp <- (tetha_i*y) + ((1-tetha_i)*Y_syn)
    mse_comp <- (1-tetha_i)*mse_syn
    rel_mse_comp <- mse_comp/Y_comp
    Syn_Comp <- data.frame(cbind(Y_syn, Y_comp,mse_syn,  mse_comp, rel_mse_syn, rel_mse_comp))
    colnames(Syn_Comp) = c("Y syn","Y comp", "MSE syn",  "MSE comp", "Relatif MSE syn","Relatif MSE comp")
    return(Syn_Comp)
  }
  
  dataset = list()
  est_dataset = list()
  for( j in 1:iterasi){
    set.seed(j)
    dataset[[j]] = propinsi(myDataY, prop)
    est_dataset [[j]] = Y_synth_comp(dataX,dataset[[j]]$Y_cap_est,dataset[[j]]$Var_cap_est,Ni)
  }
  
  databind = data.frame()
  databind_ind = data.frame()
  for (b in 1:iterasi) {
    databind = rbind(databind, dataset[[b]])
    databind_ind = rbind(databind_ind, est_dataset[[b]])
  }
  
  datafinal = aggregate(list(databind$Y_cap_est,databind_ind$`Y syn`,databind_ind$`Y comp`,
                             databind$Var_cap_est,databind_ind$`MSE syn`,databind_ind$`MSE comp`
                             ,databind$rel_var_y,databind_ind$`Relatif MSE syn`,databind_ind$`Relatif MSE comp`),
                        by=list(databind$r102),
                        FUN=mean)
  colnames(datafinal) = c("kab", "Y dir", "Y syn","Y com", "MSE dir","MSE syn","MSE com",
                          "Relatif MSE dir","Relatif MSE syn","Relatif MSE com")
  datafinal$Efisiensi_syn <- datafinal$`MSE syn`/datafinal$`MSE dir`
  datafinal$Efisiensi_com <- datafinal$`MSE com`/datafinal$`MSE dir`
  return(datafinal)
}
  1. Fungsi Estimasi untuk metode One stage Cluster

    1. Menggunakan rumus MSE synthetic yang awal
#Pakai rumus awal
resampling_1st = function(data, dataX, proporsi,iterasi ){
  myDataY = data
  prop = proporsi
  propinsi <- function(data, prop){  
    cb_sampling <- function(data, prop){
      mydata= data
      bs_u <-unique(mydata$bs_o)
      bs_u <- data.frame(bs_u)
      samp_bs <- sample(1:nrow(bs_u), size = prop*nrow(bs_u), replace = FALSE)
      sampi= bs_u[samp_bs,]
      sampi2 = as.matrix(sampi)
      dat = as.matrix(mydata)
      hasil = c()
      for(i in 1: length(sampi2)){
        hasil = rbind(hasil,dat[dat[,1]==sampi[i],])
      }
      hasil <- data.frame(hasil)
      hasil$pop = as.numeric(paste(hasil$pop))
      est_ybar_1cs <- function(data,f){
        hs_sam <- data
        Mi <- data.frame(table(hs_sam$bs_o))
        y_bar_i <- aggregate(hs_sam$pop, by=list(hs_sam$bs_o), FUN=mean)
        y_bar_n <- (sum(y_bar_i$x*Mi$Freq))/sum(Mi$Freq)
        M_bar <- sum(Mi$Freq)/nrow(Mi)
        pnyb <- sum((Mi$Freq^2)*((y_bar_i$x-rep(c(y_bar_n),nrow(Mi)))^2))
        pmbg <- nrow(Mi)*(M_bar)^2*(nrow(Mi)-1)
        var_y_bar_n <- (1-f)*pnyb/pmbg 
        Y_cap_est <- (nrow(Mi)/f)*M_bar*y_bar_n
        Var_cap_est <- ((nrow(Mi)/f)*M_bar)^2*var_y_bar_n
        rel_var_y <- Var_cap_est/Y_cap_est
        hasil <- cbind(Y_cap_est,Var_cap_est,rel_var_y)
        return(hasil)
      }
      result = est_ybar_1cs(hasil, prop)
      
    }
    
    r102 = unique(dt1$kab)
    datakoeh = list()
    for(b in r102){
      datakoeh[[b]] <- subset(dt1, kab %in% b)
    }
    
    try_ye <- list()
    for(c in r102){
      try_ye[[c]] <- cb_sampling(data = datakoeh[[c]], prop = prop)  
    }
    
    this_it = data.frame()
    for (q in r102) {
      this_it <- rbind(this_it, try_ye[[q]])
    }
    this_it = cbind(r102, this_it)
  }  
  #fungsi estimasi synthetic dan composite
  Y_synth_comp <- function(x,y,vary){
    #synthetic function
    xty <- t(x)%*%y
    xtx <- t(x)%*%x
    bt_xy <- solve(xtx)%*%xty
    bt_xy = t(bt_xy)
    Y_syn <- c(rep(0,nrow(x)))
    for(i in 1: ncol(x)){
      Y_syn = Y_syn + x[,i]*bt_xy[,i]
    }
    Y_syn <- as.data.frame(Y_syn)
    mse_syn <- ((Y_syn-y)^2)-vary
    rel_mse_syn <- mse_syn/Y_syn
    #composite function
    tetha_i <- mse_syn/(vary+mse_syn)
    tetha_i[tetha_i<0]<-0
    tetha_i[tetha_i>1]<-1
    Y_comp <- (tetha_i*y) + ((1-tetha_i)*Y_syn)
    mse_comp <- (1-tetha_i)*mse_syn
    rel_mse_comp <- mse_comp/Y_comp
    Syn_Comp <- data.frame(cbind(Y_syn, Y_comp,mse_syn,  mse_comp, rel_mse_syn, rel_mse_comp))
    colnames(Syn_Comp) = c("Y syn","Y comp", "MSE syn",  "MSE comp", "Relatif MSE syn","Relatif MSE comp")
    return(Syn_Comp)
  }
  
  dataset = list()
  est_dataset = list()
  for( j in 1:iterasi){
    set.seed(j)
    dataset[[j]] = propinsi(myDataY, prop)
    est_dataset [[j]] = Y_synth_comp(dataX,dataset[[j]]$Y_cap_est,dataset[[j]]$Var_cap_est)
  }
  
  databind = data.frame()
  databind_ind = data.frame()
  for (b in 1:iterasi) {
    databind = rbind(databind, dataset[[b]])
    databind_ind = rbind(databind_ind, est_dataset[[b]])
  }
  
  datafinal = aggregate(list(databind$Y_cap_est,databind_ind$`Y syn`,databind_ind$`Y comp`,
                             databind$Var_cap_est,databind_ind$`MSE syn`,databind_ind$`MSE comp`
                             ,databind$rel_var_y,databind_ind$`Relatif MSE syn`,databind_ind$`Relatif MSE comp`),
                        by=list(databind$r102),
                        FUN=mean)
  colnames(datafinal) = c("kab", "Y dir", "Y syn","Y com", "MSE dir","MSE syn","MSE com",
                          "Relatif MSE dir","Relatif MSE syn","Relatif MSE com")
  datafinal$Efisiensi_syn <- datafinal$`MSE syn`/datafinal$`MSE dir`
  datafinal$Efisiensi_com <- datafinal$`MSE com`/datafinal$`MSE dir`
  return(datafinal)
}
b. Menggunakan rumus MSE synthetic yang perbaikan
resampling_1st_2 <- function(data, dataX, Ni, proporsi,iterasi ){
  myDataY <- data
  prop <- proporsi
  propinsi <- function(data, prop){  
    cb_sampling <- function(data, prop){
      mydata<- data
      bs_u <-unique(mydata$bs_o)
      bs_u <- data.frame(bs_u)
      samp_bs <- sample(1:nrow(bs_u), size = prop*nrow(bs_u), replace = FALSE)
      sampi=bs_u[samp_bs,]
      sampi2 = as.matrix(sampi)
      dat <- as.matrix(mydata)
      hasil <- c()
      for(i in 1: length(sampi2)){
        hasil = rbind(hasil,dat[dat[,1]==sampi[i],])
      }
      hasil <- data.frame(hasil)
      hasil$pop <- as.numeric(paste(hasil$pop))
      est_ybar_1cs <- function(data,f){
        hs_sam <- data
        Mi <- data.frame(table(hs_sam$bs_o))
        y_bar_i <- aggregate(hs_sam$pop, by=list(hs_sam$bs_o), FUN=mean)
        y_bar_n <- (sum(y_bar_i$x*Mi$Freq))/sum(Mi$Freq)
        M_bar <- sum(Mi$Freq)/nrow(Mi)
        pnyb <- sum((Mi$Freq^2)*((y_bar_i$x-rep(c(y_bar_n),nrow(Mi)))^2))
        pmbg <- nrow(Mi)*(M_bar)^2*(nrow(Mi)-1)
        var_y_bar_n <- (1-f)*pnyb/pmbg 
        Y_cap_est <- (nrow(Mi)/f)*M_bar*y_bar_n
        Var_cap_est <- ((nrow(Mi)/f)*M_bar)^2*var_y_bar_n
        rel_var_y <- Var_cap_est/Y_cap_est
        hasil <- cbind(Y_cap_est,Var_cap_est,rel_var_y)
        return(hasil)
      }
      result <- est_ybar_1cs(hasil, prop)
      
    }
    
    r102 = unique(dt1$kab)
    datakoeh = list()
    for(b in r102){
      datakoeh[[b]] <- subset(dt1, kab %in% b)
    }
    
    try_ye <- list()
    for(c in r102){
      try_ye[[c]] <- cb_sampling(data = datakoeh[[c]], prop = prop)  
    }
    
    this_it = data.frame()
    for (q in r102) {
      this_it <- rbind(this_it, try_ye[[q]])
    }
    this_it = cbind(r102, this_it)
  }
  
  #fungsi estimasi synthetic dan composite
  Y_synth_comp <- function(x,y,vary,Ni){
    #synthetic function
    N <- Ni
    xty <- t(x)%*%y
    xtx <- t(x)%*%x
    bt_xy <- solve(xtx)%*%xty
    bt_xy = t(bt_xy)
    Y_syn <- c(rep(0,nrow(x)))
    for(i in 1: ncol(x)){
      Y_syn = Y_syn + x[,i]*bt_xy[,i]
    }
    m <- length(Y_syn)
    Y_syn <- as.data.frame(Y_syn)
    mse <- sum((y - Y_syn)^2)/m-2
    var_y_cap_is <- c(rep(mse,m))
    Ni_2 <- N^2
    ba.1 <- (sum((Y_syn-y)^2/Ni_2))/m
    ba.2 <- (sum(rep(var(Y_syn-y),m)/Ni_2))/m
    ba_a <- ba.1 - ba.2 
    mse_syn <- var_y_cap_is + (Ni_2*ba_a)
    rel_mse_syn <- mse_syn/Y_syn
    #composite function
    tetha_i <- mse_syn/(vary+mse_syn)
    tetha_i[tetha_i<0]<-0
    tetha_i[tetha_i>1]<-1
    Y_comp <- (tetha_i*y) + ((1-tetha_i)*Y_syn)
    mse_comp <- (1-tetha_i)*mse_syn
    rel_mse_comp <- mse_comp/Y_comp
    Syn_Comp <- data.frame(cbind(Y_syn, Y_comp,mse_syn,  mse_comp, rel_mse_syn, rel_mse_comp))
    colnames(Syn_Comp) = c("Y syn","Y comp", "MSE syn",  "MSE comp", "Relatif MSE syn","Relatif MSE comp")
    return(Syn_Comp)
  }
  
  dataset = list()
  est_dataset = list()
  for( j in 1:iterasi){
    set.seed(j)
    dataset[[j]] = propinsi(myDataY, prop)
    est_dataset [[j]] = Y_synth_comp(dataX,dataset[[j]]$Y_cap_est,dataset[[j]]$Var_cap_est,Ni)
  }
  
  databind = data.frame()
  databind_ind = data.frame()
  for (b in 1:iterasi) {
    databind = rbind(databind, dataset[[b]])
    databind_ind = rbind(databind_ind, est_dataset[[b]])
  }
  
  datafinal = aggregate(list(databind$Y_cap_est,databind_ind$`Y syn`,databind_ind$`Y comp`,
                             databind$Var_cap_est,databind_ind$`MSE syn`,databind_ind$`MSE comp`
                             ,databind$rel_var_y,databind_ind$`Relatif MSE syn`,databind_ind$`Relatif MSE comp`),
                        by=list(databind$r102),
                        FUN=mean)
  colnames(datafinal) = c("kab", "Y dir", "Y syn","Y com", "MSE dir","MSE syn","MSE com",
                          "Relatif MSE dir","Relatif MSE syn","Relatif MSE com")
  datafinal$Efisiensi_syn <- datafinal$`MSE syn`/datafinal$`MSE dir`
  datafinal$Efisiensi_com <- datafinal$`MSE com`/datafinal$`MSE dir`
  return(datafinal)
}
  1. Running semua metode dengan persentase dari jumlah sampel yang berbeda
res_srs_1 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 1, iterasi = 100)
res_srs2_1 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 1, iterasi = 100)

res_srs_0.9 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.9, iterasi = 100)
res_srs2_0.9 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.9, iterasi = 100)

res_srs_0.8 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.8, iterasi = 100)
res_srs2_0.8 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.8, iterasi = 100)

res_srs_0.7 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.7, iterasi = 100)
res_srs2_0.7 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.7, iterasi = 100)

res_srs_0.6 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.6, iterasi = 100)
res_srs2_0.6 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.6, iterasi = 100)

res_srs_0.5 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.5, iterasi = 100)
res_srs2_0.5 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.5, iterasi = 100)

res_srs_0.4 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.4, iterasi = 100)
res_srs2_0.4 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.4, iterasi = 100)

res_srs_0.3 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.3, iterasi = 100)
res_srs2_0.3 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.3, iterasi = 100)

res_srs_0.2 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.2, iterasi = 100)
res_srs2_0.2 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.2, iterasi = 100)

res_srs_0.1 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.1, iterasi = 100)
res_srs2_0.1 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.1, iterasi = 100)

res_srs_0.05 <- resampling_srs(data = dt1, dataX = mat_x, proporsi = 0.05, iterasi = 100)
res_srs2_0.05 <- resampling_srs_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.05, iterasi = 100)
res_1sc_1 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 1, iterasi = 100)
res_1sc2_1 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 1, iterasi = 100)

res_1sc_0.9 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.9, iterasi = 100)
res_1sc2_0.9 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta , proporsi = 0.9, iterasi = 100)

res_1sc_0.8 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.8, iterasi = 100)
res_1sc2_0.8 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.8, iterasi = 100)

res_1sc_0.7 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.7, iterasi = 100)
res_1sc2_0.7 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.7, iterasi = 100)

res_1sc_0.6 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.6, iterasi = 100)
res_1sc2_0.6 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.6, iterasi = 100)

res_1sc_0.5 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.5, iterasi = 100)
res_1sc2_0.5 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.5, iterasi = 100)

res_1sc_0.4 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.4, iterasi = 100)
res_1sc2_0.4 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.4, iterasi = 100)

res_1sc_0.3 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.3, iterasi = 100)
res_1sc2_0.3 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.3, iterasi = 100)

res_1sc_0.2 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.2, iterasi = 100)
res_1sc2_0.2 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.2, iterasi = 100)

res_1sc_0.1 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.1, iterasi = 100)
res_1sc2_0.1 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.1, iterasi = 100)

res_1sc_0.05 <- resampling_1st(data = dt1, dataX = mat_x, proporsi = 0.05, iterasi = 100)
res_1sc2_0.05 <- resampling_1st_2(data = dt1, dataX = mat_x, Ni = Ni_ruta, proporsi = 0.05, iterasi = 100)
  1. Hasil Perhitungan:
  1. MEnggunakan rumus MSE synthetic yang awal

    1. Metode SRS
      1. f = 100%
res_srs_1
##    kab   Y dir   Y syn   Y com MSE dir      MSE syn MSE com
## 1    1 1637409 1484546 1637409       0  23367160158       0
## 2   10 2452226 2656398 2452226       0  41686037135       0
## 3   11 1432925 1736676 1432925       0  92264682627       0
## 4   12 1628141 2070386 1628141       0 195581155363       0
## 5   13 1660654 1452773 1660654       0  43214520571       0
## 6   14 2677707 2617885 2677707       0   3578628369       0
## 7   15 5059790 4863519 5059790       0  38522139703       0
## 8   16 2702258 2596479 2702258       0  11189241307       0
## 9   17 2063216 2280593 2063216       0  47252536988       0
## 10  18 1802921 1720645 1802921       0   6769362207       0
## 11  19 1893080 2266122 1893080       0 139160429063       0
## 12   2 1631372 1473225 1631372       0  25010528782       0
## 13  20 1933963 1539654 1933963       0 155479806202       0
## 14  21 1543883 1871616 1543883       0 107408906085       0
## 15  22 2024290 1859814 2024290       0  27052299781       0
## 16  23 2145480 2562473 2145480       0 173883605020       0
## 17  24 2721467 2698896 2721467       0    509476091       0
## 18  25 3923463 3722909 3923463       0  40222101589       0
## 19  26 2049321 2256961 2049321       0  43114400382       0
## 20  27 1850200 1379119 1850200       0 221917551646       0
## 21  28 1632444 1899669 1632444       0  71409379673       0
## 22  29 1945828 2049705 1945828       0  10790438814       0
## 23   3 1794553 1899490 1794553       0  11011912392       0
## 24   4 2297582 2449242 2297582       0  23000653140       0
## 25   5 2083579 1902456 2083579       0  32805645589       0
## 26   6 2526531 2124414 2526531       0 161698161955       0
## 27   7 2716794 3050885 2716794       0 111616270475       0
## 28  71 2297609 2314435 2297609       0    283139160       0
## 29  72 1872873 2081921 1872873       0  43701295609       0
## 30  73 3484448 3097221 3484448       0 149945060415       0
## 31  74 2197198 2088987 2197198       0  11709568505       0
## 32  75 1867766 2160606 1867766       0  85755048745       0
## 33  76 2088732 1998934 2088732       0   8063635637       0
## 34  77 2275392 2228054 2275392       0   2240872147       0
## 35  78 7020112 6960868 7020112       0   3509873670       0
## 36  79 2178314 2012520 2178314       0  27487633079       0
## 37   8 2025630 1758243 2025630       0  71496025026       0
## 38   9 2279804 2230617 2279804       0   2419373518       0
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1                0      15740.2769               0           Inf
## 2                0      15692.6939               0           Inf
## 3                0      53127.1634               0           Inf
## 4                0      94466.0213               0           Inf
## 5                0      29746.2278               0           Inf
## 6                0       1366.9922               0           Inf
## 7                0       7920.6305               0           Inf
## 8                0       4309.3906               0           Inf
## 9                0      20719.4082               0           Inf
## 10               0       3934.2014               0           Inf
## 11               0      61409.0701               0           Inf
## 12               0      16976.7190               0           Inf
## 13               0     100983.6028               0           Inf
## 14               0      57388.3367               0           Inf
## 15               0      14545.7042               0           Inf
## 16               0      67857.7295               0           Inf
## 17               0        188.7721               0           Inf
## 18               0      10803.9457               0           Inf
## 19               0      19102.8585               0           Inf
## 20               0     160912.5386               0           Inf
## 21               0      37590.4229               0           Inf
## 22               0       5264.3865               0           Inf
## 23               0       5797.2981               0           Inf
## 24               0       9390.9274               0           Inf
## 25               0      17243.8418               0           Inf
## 26               0      76114.2496               0           Inf
## 27               0      36584.8880               0           Inf
## 28               0        122.3362               0           Inf
## 29               0      20990.8477               0           Inf
## 30               0      48412.7746               0           Inf
## 31               0       5605.3812               0           Inf
## 32               0      39690.2743               0           Inf
## 33               0       4033.9683               0           Inf
## 34               0       1005.7531               0           Inf
## 35               0        504.2293               0           Inf
## 36               0      13658.3135               0           Inf
## 37               0      40663.3405               0           Inf
## 38               0       1084.6208               0           Inf
##    Efisiensi_com
## 1            NaN
## 2            NaN
## 3            NaN
## 4            NaN
## 5            NaN
## 6            NaN
## 7            NaN
## 8            NaN
## 9            NaN
## 10           NaN
## 11           NaN
## 12           NaN
## 13           NaN
## 14           NaN
## 15           NaN
## 16           NaN
## 17           NaN
## 18           NaN
## 19           NaN
## 20           NaN
## 21           NaN
## 22           NaN
## 23           NaN
## 24           NaN
## 25           NaN
## 26           NaN
## 27           NaN
## 28           NaN
## 29           NaN
## 30           NaN
## 31           NaN
## 32           NaN
## 33           NaN
## 34           NaN
## 35           NaN
## 36           NaN
## 37           NaN
## 38           NaN

Rata-rata efisiensi:

rt_syn_1_1 <- mean(res_srs_1$Efisiensi_syn)
rt_com_1_1 <- mean(res_srs_1$Efisiensi_com)
rt_syn_1_1
## [1] Inf
rt_com_1_1
## [1] NaN
      b. f = 90%
res_srs_0.9
##    kab   Y dir   Y syn   Y com    MSE dir      MSE syn    MSE com
## 1    1 1637950 1483833 1635318  402455800  23816617552  395454784
## 2   10 2450030 2654313 2452799  557099538  41672541869  549271772
## 3   11 1427539 1735603 1428722  361164162  94918548665  359732480
## 4   12 1627050 2068453 1627769  316631546 194826494509  316108756
## 5   13 1659070 1452264 1657314  361885648  42791087893  358786582
## 6   14 2676482 2616771 2667092  512694594   3436062901  397892551
## 7   15 5063089 4862328 5050373 2477638157  39127830965 2311198536
## 8   16 2700715 2595871 2695284  547294945  10863919169  516347658
## 9   17 2063877 2279751 2065844  418649197  46636587984  414691320
## 10  18 1800682 1719622 1795991  359734753   6559949418  336148735
## 11  19 1892716 2264843 1893876  429732922 138379683280  428373245
## 12   2 1629238 1472153 1626906  362173025  24714672063  356674664
## 13  20 1934881 1538533 1932922  776053326 156904429035  772206886
## 14  21 1542883 1869929 1543882  324828697 106964200145  323821505
## 15  22 2023100 1859744 2021069  329032516  26640172535  324870471
## 16  23 2144757 2561868 2145760  416394000 174008120443  415379465
## 17  24 2723196 2701128 2710669  764955135    237886050 -115206081
## 18  25 3921741 3723463 3915053 1301678096  38799028941 1256047126
## 19  26 2050800 2255073 2052385  321073774  41686910382  318531582
## 20  27 1847144 1378056 1846459  321479344 219882264572  321007818
## 21  28 1632488 1897329 1633882  366948432  70019637502  364985631
## 22  29 1942709 2045140 1947135  447958062  10168664141  427942856
## 23   3 1790989 1897676 1797214  613085059  11402418965  569505301
## 24   4 2299061 2447583 2305145  869928097  21818074695  831023606
## 25   5 2079982 1900623 2077241  488262198  32107105454  480695905
## 26   6 2527640 2121998 2525785  751388354 164456207950  747942173
## 27   7 2717801 3050413 2719118  436441679 110496240564  434694938
## 28  71 2288263 2312975 2299949 1142795661    486458993 -379600925
## 29  72 1871201 2080292 1876597 1096658962  43473481291 1066238243
## 30  73 3481539 3093549 3477625 1513355241 149955157512 1497985039
## 31  74 2199782 2087311 2195556  458395346  12686842659  439898870
## 32  75 1867030 2159140 1869416  688724057  85287578415  682926163
## 33  76 2094468 1997346 2082901 1060924348   8927199264  917643563
## 34  77 2270178 2226235 2249376 1384027135   1548340918  209219150
## 35  78 7007674 6951401 6957005 4233355393   -780172025 -955540884
## 36  79 2174836 2010955 2170755  659235024  26759211207  642362101
## 37   8 2018998 1757221 2017238  459833109  68491188764  456727691
## 38   9 2277752 2228548 2269465  384197825   2295222115  291683878
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         245.4791     16062.37120       241.58913    59.1782192
## 2         227.3021     15700.56892       223.86057    74.8026860
## 3         252.7535     54691.29337       251.54347   262.8127556
## 4         194.5243     94186.33774       194.11724   615.3098047
## 5         217.9639     29471.70347       216.32436   118.2447775
## 6         191.5193      1312.99506       148.82681     6.7019683
## 7         489.2314      8045.13219       457.40553    15.7923912
## 8         202.6038      4185.27097       191.48675    19.8502092
## 9         202.7657     20455.75215       200.66111   111.3977723
## 10        199.7027      3817.33684       187.00937    18.2355176
## 11        226.9594     61096.70281       226.10301   322.0132232
## 12        222.1836     16796.11069       219.11503    68.2399580
## 13        400.8621    101985.45450       399.27846   202.1825355
## 14        210.4538     57197.05324       209.66628   329.2941822
## 15        162.6065     14329.86506       160.70847    80.9651667
## 16        194.0863     67920.37204       193.52331   417.8929577
## 17        280.7516        89.08811       -42.95664     0.3109804
## 18        331.8386     10419.76946       320.72377    29.8069308
## 19        156.5364     18481.28224       155.17836   129.8359248
## 20        173.9699    159579.93037       173.77948   683.9701172
## 21        224.6989     36904.08121       223.30766   190.8160152
## 22        230.4013      4968.36107       219.61443    22.7000360
## 23        341.9425      6007.93898       316.72240    18.5984290
## 24        378.1349      8915.01278       360.32773    25.0803196
## 25        234.6102     16893.33397       231.27339    65.7579177
## 26        297.1401     77500.19672       295.99353   218.8697856
## 27        160.5609     36220.23290       159.84113   253.1752713
## 28        498.9161       211.06566      -162.03186     0.4256745
## 29        585.4541     20898.58357       567.62946    39.6417508
## 30        434.5681     48471.24681       430.63398    99.0878767
## 31        208.3221      6080.51036       200.26713    27.6766393
## 32        368.7004     39497.56805       365.13654   123.8341793
## 33        506.2638      4470.12322       439.80688     8.4145484
## 34        609.2050       695.09635        89.12672     1.1187215
## 35        604.0266      -113.13515      -138.42232    -0.1842916
## 36        302.9376     13305.50187       295.71700    40.5913069
## 37        227.6472     38982.05220       226.30571   148.9479278
## 38        168.6239      1030.73095       128.16990     5.9740633
##    Efisiensi_com
## 1      0.9826043
## 2      0.9859491
## 3      0.9960359
## 4      0.9983489
## 5      0.9914363
## 6      0.7760810
## 7      0.9328233
## 8      0.9434541
## 9      0.9905461
## 10     0.9344350
## 11     0.9968360
## 12     0.9848184
## 13     0.9950436
## 14     0.9968993
## 15     0.9873507
## 16     0.9975635
## 17    -0.1506050
## 18     0.9649445
## 19     0.9920822
## 20     0.9985333
## 21     0.9946510
## 22     0.9553190
## 23     0.9289173
## 24     0.9552785
## 25     0.9845036
## 26     0.9954136
## 27     0.9959978
## 28    -0.3321687
## 29     0.9722605
## 30     0.9898436
## 31     0.9596495
## 32     0.9915817
## 33     0.8649472
## 34     0.1511669
## 35    -0.2257171
## 36     0.9744053
## 37     0.9932466
## 38     0.7592023

Rata-rata efisiensi:

rt_syn_1_0.9 <- mean(res_srs_0.9$Efisiensi_syn)
rt_com_1_0.9 <- mean(res_srs_0.9$Efisiensi_com)
rt_syn_1_0.9
## [1] 127.8254
rt_com_1_0.9
## [1] 0.8474652
      c. f = 80%
res_srs_0.8
##    kab   Y dir   Y syn   Y com    MSE dir      MSE syn     MSE com
## 1    1 1639780 1483803 1633750  919625802  24428167183   881935144
## 2   10 2447781 2654147 2454016 1243869640  42300253598  1202864203
## 3   11 1433045 1734770 1435824  824183467  90939100800   816112347
## 4   12 1630086 2069539 1631715  708581283 193287884149   705849015
## 5   13 1661093 1452800 1657129  820771653  43391023569   804884717
## 6   14 2674741 2616757 2658170 1122671712   3212520588   470608989
## 7   15 5060801 4864062 5030832 5545086783  35478864345  4579003289
## 8   16 2689936 2594761 2675972 1198420257   9084522220   915739953
## 9   17 2064539 2277695 2069119  946993461  45394395437   924989691
## 10  18 1797108 1717211 1786180  797287196   6438946653   636284335
## 11  19 1887099 2263562 1889625  939015769 141731209521   932432608
## 12   2 1624684 1469152 1619324  815433485  24159569233   786117678
## 13  20 1923422 1537323 1919041 1691978325 149327912088  1672651309
## 14  21 1541665 1867975 1543883  715239562 106397142007   710170011
## 15  22 2017671 1855103 2013081  735005217  26218629689   713589068
## 16  23 2155830 2560944 2158193  948375390 164029400790   942683346
## 17  24 2724848 2699051 2706902 1760386684   -103946614  -502522597
## 18  25 3922965 3724353 3907760 2920020355  38047897697  2680899694
## 19  26 2048536 2255033 2052104  719886064  42623955243   706715532
## 20  27 1847701 1379940 1846183  711359832 218619310334   709022941
## 21  28 1634144 1899721 1637304  828221618  70307984292   817991877
## 22  29 1945016 2050055 1955169 1023140588  10331700396   912265985
## 23   3 1793947 1897861 1809383 1395390064  10552106803  1098013618
## 24   4 2295009 2446453 2309550 1916328728  22926397769  1653895797
## 25   5 2081892 1900055 2075611 1122636524  32823515137  1082575172
## 26   6 2528004 2119956 2523792 1713315458 166345109617  1695469881
## 27   7 2716072 3051718 2719000  977407849 112128470268   968744524
## 28  71 2295165 2315165 2300375 2615668686     35809366 -1276306306
## 29  72 1869626 2082161 1881746 2414130748  44531511625  2249624749
## 30  73 3490320 3096499 3481405 3471167619 154190531338  3390767631
## 31  74 2197964 2089424 2187664 1035289894  11578111628   901463904
## 32  75 1869696 2161092 1875219 1572726951  84662565789  1541092205
## 33  76 2090132 1999232 2065954 2378655121   7967791506  1262202603
## 34  77 2275681 2228257 2252415 3091588288   2471166124   130386212
## 35  78 7013607 6956193 6956927 9577135301  -5663983043 -5676998388
## 36  79 2177799 2012784 2168452 1484193904  26874642372  1392344841
## 37   8 2025710 1757294 2021740 1059226537  71958396569  1043362806
## 38   9 2275558 2226769 2259132  851434210   2139834400   340987881
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         559.8589     16493.27509       538.79376   26.56315984
## 2         507.8006     15939.09556       489.88201   34.00698291
## 3         574.1203     52421.74500       567.40494  110.33841910
## 4         434.0884     93386.55913       431.98258  272.78152670
## 5         493.3348     29888.76029       484.92378   52.86613327
## 6         419.4313      1226.90301       174.24237    2.86149598
## 7        1095.2072      7290.52968       908.40353    6.39825231
## 8         445.2618      3503.41692       340.38017    7.58041444
## 9         458.2678     19931.48752       446.67364   47.93527867
## 10        443.2183      3755.15003       354.43151    8.07606930
## 11        497.1211     62611.72755       492.98102  150.93592065
## 12        501.3925     16459.21095       484.87901   29.62788463
## 13        877.6568     97153.06276       869.59702   88.25639776
## 14        463.3682     56960.47534       459.42824  148.75735024
## 15        364.0767     14144.08018       354.25108   35.67135182
## 16        439.6350     64048.19065       436.52164  172.95830583
## 17        645.3347       -37.56296      -186.72876   -0.05904760
## 18        743.9634     10210.62137       685.42817   13.03001112
## 19        351.2494     18889.82939       344.24171   59.20930740
## 20        384.4822    158484.73652       383.53883  307.32591390
## 21        506.4785     37008.70801       499.27549   84.89030324
## 22        525.1596      5035.40414       466.01138   10.09802614
## 23        776.5188      5558.97929       608.23821    7.56211978
## 24        833.4142      9370.31297       716.55576   11.96370823
## 25        538.7771     17270.82790       521.03770   29.23788281
## 26        677.1027     78475.91000       671.15825   97.08959834
## 27        359.7469     36737.52723       356.17644  114.72024744
## 28       1137.2634        15.89265      -546.84286    0.01369033
## 29       1287.2248     21389.12495      1192.37774   18.44618883
## 30        993.9386     49802.21674       973.32864   44.42036463
## 31        470.8496      5542.34230       410.98986   11.18344890
## 32        840.4495     39166.85945       821.19940   53.83170025
## 33       1135.8768      3982.76908       598.73278    3.34970439
## 34       1354.8918      1107.00256        46.20204    0.79931928
## 35       1364.9743      -816.67598      -818.54784   -0.59140681
## 36        680.9547     13358.88756       641.24875   18.10723134
## 37        522.4494     40969.74307       515.61896   67.93485061
## 38        373.9557       962.95214       149.15377    2.51321168
##    Efisiensi_com
## 1     0.95901522
## 2     0.96703398
## 3     0.99020713
## 4     0.99614403
## 5     0.98064390
## 6     0.41918665
## 7     0.82577667
## 8     0.76412256
## 9     0.97676460
## 10    0.79806165
## 11    0.99298930
## 12    0.96404881
## 13    0.98857727
## 14    0.99291209
## 15    0.97086259
## 16    0.99399811
## 17   -0.28546149
## 18    0.91810993
## 19    0.98170470
## 20    0.99671490
## 21    0.98764855
## 22    0.89163307
## 23    0.78688651
## 24    0.86305433
## 25    0.96431494
## 26    0.98958419
## 27    0.99113643
## 28   -0.48794647
## 29    0.93185705
## 30    0.97683777
## 31    0.87073573
## 32    0.97988542
## 33    0.53063708
## 34    0.04217451
## 35   -0.59276581
## 36    0.93811519
## 37    0.98502329
## 38    0.40048647

Rata-rata efisiensi:

rt_syn_1_0.8 <- mean(res_srs_0.8$Efisiensi_syn)
rt_com_1_0.8 <- mean(res_srs_0.8$Efisiensi_com)
rt_syn_1_0.8
## [1] 56.59714
rt_com_1_0.8
## [1] 0.7694924
      d. f = 70%
res_srs_0.7
##    kab   Y dir   Y syn   Y com     MSE dir      MSE syn      MSE com
## 1    1 1639426 1483879 1629072  1559774074  24194955966   1446249480
## 2   10 2447562 2654970 2458457  2121674978  42604561180   1990029498
## 3   11 1431042 1735672 1435827  1425652326  92357592653   1401484227
## 4   12 1625684 2067821 1628457  1206640896 195560112541   1198577986
## 5   13 1662990 1453841 1655991  1448664815  43613225850   1398666193
## 6   14 2680686 2617089 2656516  1970642517   3509376640    544946562
## 7   15 5061846 4859941 5012209  9555627259  36310041800   6218202036
## 8   16 2698522 2595133 2677116  2096850852  10652771092   1424008986
## 9   17 2056607 2279864 2064235  1605599869  50078339920   1541614945
## 10  18 1802901 1719927 1786089  1403292030   6774101826    948948672
## 11  19 1894920 2263677 1899575  1673794401 136065945840   1650853144
## 12   2 1629906 1472490 1620610  1409967899  24741743425   1320536004
## 13  20 1929668 1538315 1922081  2967285094 152827622871   2909113742
## 14  21 1543480 1869632 1547395  1246082453 106512856093   1229937820
## 15  22 2028002 1860017 2020088  1292146659  28064368752   1227935011
## 16  23 2141020 2561266 2144928  1617215647 176603864288   1601443228
## 17  24 2724640 2700996 2709459  3037863835   -508488408  -1132637439
## 18  25 3916633 3721676 3889281  4967565878  35960095447   4165470789
## 19  26 2048962 2254388 2055224  1242697963  42071781550   1201578257
## 20  27 1846824 1379007 1844245  1210827542 218493303794   1204027518
## 21  28 1631258 1897240 1636731  1418416779  70431536217   1386951465
## 22  29 1941901 2045450 1960012  1710370698   9795916414   1320149949
## 23   3 1792194 1897280 1818820  2372906958  10603496554   1318611434
## 24   4 2293040 2446923 2317371  3280618704  23451281083   2339871618
## 25   5 2083704 1901181 2073108  1866861662  32858246203   1749556489
## 26   6 2528186 2122537 2520887  2940510400 164204697816   2886792872
## 27   7 2720633 3052788 2725773  1682525230 109847609016   1655438310
## 28  71 2300438 2311118 2302366  4472031300   -717862548  -1798284186
## 29  72 1871024 2078374 1895332  4247972892  43065541527   3482716253
## 30  73 3480240 3091258 3464690  5919522541 150300975094   5672963018
## 31  74 2203982 2085563 2188332  1746819520  13690389486   1443387290
## 32  75 1857672 2157231 1866855  2637899531  89243759401   2546617514
## 33  76 2092686 1995526 2059632  4137882775   9076211552   1471883102
## 34  77 2257345 2224207 2232561  5168087718    738456231  -1163296245
## 35  78 7004214 6946581 6946780 16260783068 -11586652723 -11590619526
## 36  79 2171649 2009237 2154978  2514593575  26288645726   2195600537
## 37   8 2020381 1757836 2013534  1778010383  69065575884   1730519542
## 38   9 2279357 2231296 2258124  1487553668   1977511353    144692288
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         948.4946      16339.1786       884.57759    15.5118336
## 2         865.8880      16044.6202       809.04050    20.0806257
## 3         994.2230      53216.3634       974.15890    64.7826900
## 4         740.5269      94564.0340       734.32431   162.0698529
## 5         868.8646      30022.4644       842.32915    30.1058087
## 6         734.5414       1341.4026       199.96908     1.7808286
## 7        1885.9028       7466.2539      1229.30978     3.7998596
## 8         775.9973       4106.0740       527.31598     5.0803666
## 9         779.3149      21965.1616       745.74529    31.1898007
## 10        776.9804       3938.3311       525.22723     4.8272930
## 11        881.4544      60106.6305       867.28155    81.2919112
## 12        863.4789      16818.6755       812.83197    17.5477353
## 13       1533.3437      99380.0378      1509.16208    51.5041926
## 14        805.5762      56962.8080       793.16978    85.4781767
## 15        636.5243      15105.4821       607.10281    21.7191822
## 16        754.6409      68935.6028       745.94238   109.2024212
## 17       1112.4244       -184.5675      -419.17611    -0.1673835
## 18       1267.3165       9666.2370      1068.31022     7.2389771
## 19        606.0815      18639.3373       584.32552    33.8551947
## 20        654.2852     158602.0595       651.54177   180.4495655
## 21        868.1137      37121.0945       846.11973    49.6550360
## 22        878.1553       4777.7336       672.91953     5.7273645
## 23       1319.4173       5592.9849       735.02297     4.4685682
## 24       1425.5540       9584.6672      1015.46102     7.1484324
## 25        894.7508      17291.6059       842.29909    17.6007933
## 26       1161.4828      77389.6494      1143.50022    55.8422435
## 27        618.0858      35973.5130       607.01185    65.2873473
## 28       1936.2534       -307.1674      -773.31974    -0.1605227
## 29       2257.3263      20728.3217      1837.01903    10.1379040
## 30       1698.8270      48596.3486      1634.87576    25.3907260
## 31        791.8716       6575.8918       657.16295     7.8373234
## 32       1417.7577      41355.4697      1362.46472    33.8313716
## 33       1969.5744       4546.5912       683.11398     2.1934434
## 34       2278.4535        333.1656      -529.68889     0.1428877
## 35       2319.8812      -1671.2478     -1671.83042    -0.7125520
## 36       1155.6296      13099.4937      1013.89170    10.4544313
## 37        878.4006      39306.4726       857.74204    38.8443040
## 38        651.8946        893.9073        60.23191     1.3293714
##    Efisiensi_com
## 1     0.92721728
## 2     0.93795210
## 3     0.98304769
## 4     0.99331789
## 5     0.96548641
## 6     0.27653243
## 7     0.65073719
## 8     0.67911792
## 9     0.96014890
## 10    0.67623036
## 11    0.98629386
## 12    0.93657168
## 13    0.98039577
## 14    0.98704369
## 15    0.95030622
## 16    0.99024718
## 17   -0.37284009
## 18    0.83853358
## 19    0.96691094
## 20    0.99438399
## 21    0.97781659
## 22    0.77185019
## 23    0.55569454
## 24    0.71324096
## 25    0.93716451
## 26    0.98173190
## 27    0.98390103
## 28   -0.40211798
## 29    0.81985369
## 30    0.95834807
## 31    0.82629446
## 32    0.96539595
## 33    0.35570923
## 34   -0.22509220
## 35   -0.71279590
## 36    0.87314330
## 37    0.97328990
## 38    0.09726862

Rata-rata efisiensi:

rt_syn_1_0.7 <- mean(res_srs_0.7$Efisiensi_syn)
rt_com_1_0.7 <- mean(res_srs_0.7$Efisiensi_com)
rt_syn_1_0.7
## [1] 33.22019
rt_com_1_0.7
## [1] 0.7041666
      e. f = 60%
res_srs_0.6
##    kab   Y dir   Y syn   Y com     MSE dir      MSE syn      MSE com
## 1    1 1637125 1481263 1620449  2432317862  24823241703   2110396056
## 2   10 2442475 2650665 2460420  3326979523  43356938031   2941986935
## 3   11 1435409 1733680 1443369  2238408231  89136811362   2165955785
## 4   12 1629303 2068771 1633724  1898138253 193242205756   1877257140
## 5   13 1658375 1449978 1647737  2164763509  43632894914   2046042854
## 6   14 2671724 2614621 2643835  2986526338   2865505704     14078246
## 7   15 5042676 4861605 4974228 14460204278  27690050496   5142708456
## 8   16 2701020 2592868 2671324  3360105578  11160512718   1800807111
## 9   17 2055988 2275982 2067698  2439361931  47689521281   2289143328
## 10  18 1792728 1715722 1768295  2131641831   5594527157    923236896
## 11  19 1891422 2263225 1898574  2548754453 138477021536   2492414192
## 12   2 1628454 1468033 1613928  2188186217  25541136774   1961489859
## 13  20 1923350 1536237 1911854  4454728760 148996527139   4320152412
## 14  21 1543163 1867603 1549292  1924402860 105129970876   1884108233
## 15  22 2019101 1854907 2006610  1951645087  26467680644   1786126623
## 16  23 2142448 2559339 2148594  2494643483 173932494332   2454774664
## 17  24 2729487 2697062 2709619  4723588130   -580304732  -1744427126
## 18  25 3922827 3722517 3881462  7802823189  36837161342   5617790603
## 19  26 2043439 2256585 2052755  1902244029  45083881557   1809903560
## 20  27 1852547 1379604 1848331  1995383757 222876130164   1977071374
## 21  28 1634403 1900488 1643064  2226091068  70203684178   2146443663
## 22  29 1942268 2051001 1968720  2718368705  10113648756   1801291599
## 23   3 1791882 1896537 1819892  3628497038  11649499920    631200426
## 24   4 2290768 2445637 2322191  5064236234  24472123175   2163032423
## 25   5 2078041 1897898 2060997  2924851972  31738247205   2617652143
## 26   6 2527656 2118070 2516676  4466962920 167084398570   4345002680
## 27   7 2717802 3043751 2726239  2648784844 106301253765   2573179017
## 28  71 2306319 2314112 2300646  7082780833   -825545827  -2943565504
## 29  72 1872780 2081697 1909890  6671417653  41977863816   4409446795
## 30  73 3492940 3096595 3468860  9212498797 155422688800   8610162314
## 31  74 2195801 2088779 2171066  2736142398  11622021150   1569820057
## 32  75 1881399 2160321 1897926  4305908258  76749666624   3999824906
## 33  76 2084319 1998623 2044908  6376210063   6208046272    607156270
## 34  77 2265535 2227815 2236074  8047452479    604917702  -1551506284
## 35  78 7024052 6960825 6961944 25461538178 -19387760702 -19432753040
## 36  79 2172091 2011942 2145930  3968819025  25409775314   3087255120
## 37   8 2009752 1754196 1999106  2691152157  64955612602   2576159694
## 38   9 2269548 2221866 2247976  2242812812   2229901590    205207528
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1        1476.6873      16814.4082     1290.100509   10.20559117
## 2        1359.8559      16343.7972     1196.343428   13.03192212
## 3        1550.1921      51425.2525     1492.119274   39.82151698
## 4        1161.9542      93368.9742     1146.079817  101.80618058
## 5        1299.4069      30157.2317     1235.567758   20.15596380
## 6        1115.9124       1100.8285       -3.230547    0.95947779
## 7        2860.4724       5673.0508      998.881254    1.91491420
## 8        1242.2405       4312.1885      663.730306    3.32147680
## 9        1184.5723      20955.7100     1105.944443   19.54999817
## 10       1187.1683       3265.6250      509.281165    2.62451556
## 11       1342.2806      61181.2408     1307.790040   54.33125242
## 12       1340.1701      17416.6002     1209.796486   11.67228665
## 13       2306.3062      97040.1371     2249.967275   33.44682363
## 14       1244.1908      56269.5716     1213.473070   54.62991822
## 15        965.4745      14293.3664      888.452191   13.56172842
## 16       1162.3309      67940.2113     1140.576215   69.72238538
## 17       1724.9387       -206.1463     -647.761752   -0.12285253
## 18       1986.6629       9903.0267     1436.353166    4.72100424
## 19        930.1787      19946.4146      881.322380   23.70036697
## 20       1074.4625     161736.1131     1067.095450  111.69587274
## 21       1359.5719      36912.1294     1304.329746   31.53675300
## 22       1394.3780       4903.3543      916.287563    3.72048455
## 23       2011.2003       6143.6282      385.874490    3.21055792
## 24       2197.0543      10015.7573      965.025730    4.83234234
## 25       1404.2353      16727.6274     1265.174296   10.85123196
## 26       1763.0884      78915.2219     1722.249640   37.40447404
## 27        973.4781      34880.7071      942.898094   40.13208322
## 28       3054.4522       -350.2455    -1262.269037   -0.11655674
## 29       3531.9218      20201.6248     2331.407229    6.29219545
## 30       2633.4185      50212.9111     2476.393701   16.87085038
## 31       1244.2972       5573.9098      709.969696    4.24759368
## 32       2280.7934      35550.9346     2102.523899   17.82426889
## 33       3043.9774       3104.4483      246.154589    0.97362637
## 34       3534.3066        274.5239     -705.488238    0.07516884
## 35       3621.7353      -2792.8575    -2799.209083   -0.76145285
## 36       1820.2661      12651.3902     1423.313004    6.40235172
## 37       1335.1232      37047.1207     1284.574167   24.13672986
## 38        985.8628       1006.9710       84.777745    0.99424329
##    Efisiensi_com
## 1     0.86764813
## 2     0.88428165
## 3     0.96763216
## 4     0.98899916
## 5     0.94515768
## 6     0.00471392
## 7     0.35564563
## 8     0.53593766
## 9     0.93841889
## 10    0.43311070
## 11    0.97789498
## 12    0.89639988
## 13    0.96979023
## 14    0.97906123
## 15    0.91519028
## 16    0.98401823
## 17   -0.36930128
## 18    0.71996897
## 19    0.95145709
## 20    0.99082263
## 21    0.96422096
## 22    0.66263697
## 23    0.17395644
## 24    0.42711918
## 25    0.89496910
## 26    0.97269728
## 27    0.97145641
## 28   -0.41559461
## 29    0.66094600
## 30    0.93461747
## 31    0.57373478
## 32    0.92891550
## 33    0.09522212
## 34   -0.19279471
## 35   -0.76321992
## 36    0.77787752
## 37    0.95727017
## 38    0.09149561

Rata-rata efisiensi:

rt_syn_1_0.6 <- mean(res_srs_0.6$Efisiensi_syn)
rt_com_1_0.6 <- mean(res_srs_0.6$Efisiensi_com)
rt_syn_1_0.6
## [1] 21.03624
rt_com_1_0.6
## [1] 0.6224309
      f. f = 50%
res_srs_0.5
##    kab   Y dir   Y syn   Y com     MSE dir      MSE syn      MSE com
## 1    1 1634292 1483976 1608995  3647159434  23542265786   2781871922
## 2   10 2454318 2651805 2482654  5077949491  39295119624   3781158377
## 3   11 1424265 1734276 1435260  3183109192  95707245822   3038565102
## 4   12 1631493 2069023 1638133  2821429692 191220618329   2773299459
## 5   13 1658537 1448071 1643065  3182679716  44420336366   2930100434
## 6   14 2679847 2614598 2645899  4626282269   3011593059     45827558
## 7   15 5061372 4865367 4971280 22191612229  27710961375   5359120479
## 8   16 2703903 2596243 2665283  4967391133  10585497731   1743065369
## 9   17 2055037 2277704 2074116  3729544690  49675185162   3275371230
## 10  18 1797858 1717613 1766479  3233577355   6070406892    902092498
## 11  19 1890713 2266030 1901688  3903725208 140218011940   3766299521
## 12   2 1634902 1470070 1613245  3385973696  26070361260   2876400684
## 13  20 1937447 1538309 1919451  7139104612 157984048139   6806678127
## 14  21 1536018 1868973 1545099  2881449270 110624110550   2789230550
## 15  22 2027255 1856353 2008383  2975122800  28739065293   2584604549
## 16  23 2144106 2561757 2153545  3776700052 174692655458   3679721847
## 17  24 2722045 2699128 2702962  6674639299   -353076540  -2213386664
## 18  25 3923728 3725649 3865835 11662098725  34322467038   6562469069
## 19  26 2041433 2253770 2056265  2820994939  45270837191   2551024995
## 20  27 1845328 1374467 1839391  2808069690 220961143178   2770845680
## 21  28 1627384 1896094 1640702  3306080090  71911901461   3099670308
## 22  29 1940171 2044393 1976206  3982806073   9015899076   1418260780
## 23   3 1794141 1897924 1827189  5591362677  10567864302    380383455
## 24   4 2296178 2447393 2343961  7927137605  21338170992   1996346959
## 25   5 2085535 1898391 2060236  4427734487  34533780985   3659930016
## 26   6 2506643 2119212 2489406  6576632460 149273133227   6272386151
## 27   7 2709186 3044986 2721199  3911427478 111212631578   3758061347
## 28  71 2294160 2317185 2302582 10321504318  -1408771162  -4108240156
## 29  72 1892722 2084599 1945927 10233846727  35963565539   2649979469
## 30  73 3480838 3098179 3441396 13925812961 147083854805  12187211339
## 31  74 2193458 2091308 2159669  4087433877   9868737197   1564754952
## 32  75 1875600 2163501 1900970  6354774308  83000825104   5496569997
## 33  76 2101706 2001566 2048938  9631534275   8080344270    512537267
## 34  77 2259258 2230756 2233184 12064502278   1050955753  -3286915987
## 35  78 7018980 6956897 6956897 37973125753 -31598669335 -31598669335
## 36  79 2187444 2014991 2151928  5997515917  28822650678   4118086156
## 37   8 2016385 1755735 2000055  4096364878  68024257502   3817748815
## 38   9 2273403 2220801 2246455  3377397073   2101087159    -53677007
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         2210.450      15990.0206     1699.135556    6.45495932
## 2         2063.313      14821.2868     1533.161089    7.73838332
## 3         2218.759      55169.1146     2102.224010   30.06722046
## 4         1723.415      92392.4291     1687.199491   67.77436945
## 5         1904.951      30733.9662     1768.465744   13.95689806
## 6         1721.771       1155.3728        3.077696    0.65097477
## 7         4371.784       5660.6475     1018.025150    1.24871330
## 8         1832.545       4078.2306      632.033322    2.13099743
## 9         1808.152      21794.7075     1577.932157   13.31936987
## 10        1791.634       3541.2318      481.873235    1.87730375
## 11        2055.742      61868.8703     1972.547725   35.91902721
## 12        2063.664      17775.0548     1771.077162    7.69951677
## 13        3665.901     102715.3967     3526.990963   22.12939251
## 14        1868.389      59145.2978     1798.576004   38.39183001
## 15        1465.242      15550.1303     1282.342050    9.65979128
## 16        1756.705      68186.4596     1704.503124   46.25536925
## 17        2435.458       -116.9512     -813.838764   -0.05289822
## 18        2966.801       9211.4053     1669.503340    2.94307807
## 19        1378.556      20077.3350     1240.573922   16.04782645
## 20        1514.199     161024.7805     1499.207047   78.68791291
## 21        2022.699      37913.7034     1883.279566   21.75140938
## 22        2040.656       4350.7483      727.262220    2.26370526
## 23        3093.870       5561.4167      270.481332    1.89003377
## 24        3430.672       8719.4670      910.377444    2.69178764
## 25        2115.321      18196.7176     1759.378984    7.79942453
## 26        2614.002      70411.0598     2509.318776   22.69750273
## 27        1441.660      36477.0255     1379.269428   28.43274794
## 28        4463.613       -605.0480    -1760.598185   -0.13648894
## 29        5330.888      17280.7370     1486.415428    3.51417864
## 30        3987.549      47433.6439     3515.079351   10.56195823
## 31        1860.595       4741.0760      702.181062    2.41440901
## 32        3371.640      38357.6160     2896.460599   13.06117591
## 33        4546.251       4046.5786      167.152820    0.83894674
## 34        5273.950        459.3222    -1496.325795    0.08711141
## 35        5404.877      -4545.1635    -4545.163515   -0.83213243
## 36        2729.357      14322.9887     1878.865662    4.80576477
## 37        2024.138      38803.8424     1899.921314   16.60600545
## 38        1481.813        963.8640      -31.222339    0.62210250
##    Efisiensi_com
## 1    0.762750292
## 2    0.744623077
## 3    0.954590282
## 4    0.982941190
## 5    0.920639428
## 6    0.009905915
## 7    0.241493066
## 8    0.350901574
## 9    0.878222813
## 10   0.278976625
## 11   0.964796270
## 12   0.849504734
## 13   0.953435829
## 14   0.967995716
## 15   0.868738779
## 16   0.974321973
## 17  -0.331611427
## 18   0.562717674
## 19   0.904299742
## 20   0.986743915
## 21   0.937566612
## 22   0.356095867
## 23   0.068030546
## 24   0.251837051
## 25   0.826592025
## 26   0.953738283
## 27   0.960790240
## 28  -0.398027267
## 29   0.258942658
## 30   0.875152594
## 31   0.382820860
## 32   0.864951253
## 33   0.053214499
## 34  -0.272445221
## 35  -0.832132428
## 36   0.686631968
## 37   0.931984559
## 38  -0.015893010

Rata-rata efisiensi:

rt_syn_1_0.5 <- mean(res_srs_0.5$Efisiensi_syn)
rt_com_1_0.5 <- mean(res_srs_0.5$Efisiensi_com)
rt_syn_1_0.5
## [1] 14.26236
rt_com_1_0.5
## [1] 0.5451536
      g. f = 40%
res_srs_0.4
##    kab   Y dir   Y syn   Y com     MSE dir      MSE syn      MSE com
## 1    1 1635985 1484912 1598999  5615293161  23191090392   3523443968
## 2   10 2443283 2653746 2482580  7489420770  44821685289   4391006401
## 3   11 1424325 1736256 1442828  5002347393  97688003270   4518797856
## 4   12 1629233 2070789 1638904  4069231756 194677019031   3960228885
## 5   13 1652100 1449692 1627359  4858024477  41530178319   4125325786
## 6   14 2672777 2615155 2639165  7063352890   2612795240   -764091736
## 7   15 5064000 4865144 4952697 32992121833  24225479716   3174879268
## 8   16 2710265 2597037 2666598  7523780042  12519382838   1945903993
## 9   17 2064182 2279647 2095544  5878240231  45183356366   4336507519
## 10  18 1810041 1719849 1774736  5031762593   7991533848   1072852949
## 11  19 1890016 2267496 1906702  5792774117 141922285369   5451706460
## 12   2 1637618 1472542 1604904  5109517373  25706057432   3736591612
## 13  20 1924560 1540109 1898327 10046872548 148457859048   9334043545
## 14  21 1551494 1871542 1566707  4466287293 102288424708   4188357417
## 15  22 2014916 1858605 1987088  4350353069  24238721890   3019100527
## 16  23 2145654 2562562 2160058  5678373744 173479470950   5444297267
## 17  24 2715231 2698208 2697165 10711202017  -4066562324  -5012675254
## 18  25 3932662 3724328 3856600 17678329380  36587297223   7203651499
## 19  26 2050440 2256767 2074087  4285804397  42734226031   3497706219
## 20  27 1853886 1376861 1844811  4353562993 225619301468   4265105778
## 21  28 1633092 1897509 1654036  4971697907  69241906907   4439234024
## 22  29 1938458 2042313 1988000  5998671534   6683130691   1004453019
## 23   3 1808919 1899916 1847592  9117821237   6169256557  -2080183201
## 24   4 2301896 2449221 2347337 12111593301  21341598789  -1111591011
## 25   5 2074651 1900966 2035292  6457701926  29959913477   4287681966
## 26   6 2527342 2122462 2501495 10277315076 162961585304   9588339672
## 27   7 2713645 3045620 2732341  5866126178 108171892600   5475316189
## 28  71 2293523 2317577 2299948 15211860569  -3977898032  -7794478406
## 29  72 1892051 2085300 1956781 15708995387  33186012071    708852419
## 30  73 3500227 3098180 3443950 20803931498 160008031374  17006271315
## 31  74 2194578 2091857 2154285  6045416467  10813643678   1003393453
## 32  75 1850161 2163983 1884594  9215147864  97494549241   7418378100
## 33  76 2093224 2002245 2040611 14126099819   8040048388   -925359551
## 34  77 2296378 2231321 2250052 19572434907    954221480  -5029392717
## 35  78 7010811 6958992 6958992 56491753131 -49844257661 -49844257661
## 36  79 2159707 2015634 2109111  8550169849  19422026453   3442322503
## 37   8 2020015 1756908 1995357  6274025719  68573685244   5630605299
## 38   9 2274504 2224602 2246865  5138366174   1681005945  -1198579672
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         3388.179      15746.5017       2139.2903    4.12998747
## 2         3046.889      16899.3651       1801.7722    5.98466646
## 3         3469.176      56243.7369       3104.5649   19.52843247
## 4         2481.516      94001.9339       2400.8940   47.84122180
## 5         2907.209      28737.4137       2496.3789    8.54877914
## 6         2628.751       1007.1639       -308.0007    0.36990864
## 7         6485.244       4945.1986        560.7344    0.73428074
## 8         2762.021       4811.9851        685.2367    1.66397513
## 9         2835.042      19812.0376       2087.0988    7.68654471
## 10        2766.997       4659.6258        552.2176    1.58821759
## 11        3043.259      62561.5015       2841.4959   24.49988253
## 12        3105.263      17490.5509       2290.0306    5.03101478
## 13        5161.945      96574.0623       4857.3268   14.77652457
## 14        2860.277      54639.0864       2659.6058   22.90233879
## 15        2153.226      13133.1855       1499.1740    5.57166775
## 16        2638.041      67693.9886       2513.9670   30.55090749
## 17        3911.075      -1487.4763      -1841.1620   -0.37965509
## 18        4481.190       9821.9561       1805.5103    2.06961283
## 19        2085.420      18865.0490       1694.3264    9.97110976
## 20        2334.165     164232.5060       2298.8039   51.82405810
## 21        3029.558      36459.4953       2679.8412   13.92721525
## 22        3067.985       3222.0929        524.7754    1.11410179
## 23        4987.266       3246.2848      -1022.1076    0.67661521
## 24        5198.560       8706.4960       -327.9137    1.76208020
## 25        3092.532      15776.4985       2053.8499    4.63940792
## 26        4041.432      76691.2518       3805.9588   15.85643566
## 27        2156.048      35456.7740       1999.7553   18.44008965
## 28        6560.160      -1692.6901      -3330.1994   -0.26149977
## 29        8187.052      15868.8207        626.7019    2.11254834
## 30        5914.302      51692.2163       4871.9204    7.69124006
## 31        2744.574       5212.0867        420.0386    1.78873428
## 32        4945.213      45076.7560       3962.9264   10.57981388
## 33        6650.109       3998.2237       -587.1099    0.56916265
## 34        8429.885        428.5878      -2321.1152    0.04875334
## 35        8041.461      -7156.2829      -7156.2829   -0.88232804
## 36        3935.168       9660.6391       1561.1383    2.27153692
## 37        3085.786      39148.0343       2799.1077   10.92977433
## 38        2247.644        778.0656       -551.1119    0.32714795
##    Efisiensi_com
## 1     0.62747284
## 2     0.58629453
## 3     0.90333547
## 4     0.97321291
## 5     0.84917765
## 6    -0.10817692
## 7     0.09623144
## 8     0.25863382
## 9     0.73772206
## 10    0.21321613
## 11    0.94112188
## 12    0.73130030
## 13    0.92904966
## 14    0.93777161
## 15    0.69398977
## 16    0.95877755
## 17   -0.46798438
## 18    0.40748486
## 19    0.81611429
## 20    0.97968165
## 21    0.89290100
## 22    0.16744591
## 23   -0.22814477
## 24   -0.09177909
## 25    0.66396406
## 26    0.93296154
## 27    0.93337852
## 28   -0.51239481
## 29    0.04512398
## 30    0.81745469
## 31    0.16597590
## 32    0.80501997
## 33   -0.06550708
## 34   -0.25696306
## 35   -0.88232804
## 36    0.40260282
## 37    0.89744696
## 38   -0.23326085

Rata-rata efisiensi:

rt_syn_1_0.4 <- mean(res_srs_0.4$Efisiensi_syn)
rt_com_1_0.4 <- mean(res_srs_0.4$Efisiensi_com)
rt_syn_1_0.4
## [1] 9.381166
rt_com_1_0.4
## [1] 0.4346928
      h. f = 30%
res_srs_0.3
##    kab   Y dir   Y syn   Y com     MSE dir      MSE syn      MSE com
## 1    1 1628704 1480832 1583080  8398705154  23363985185   3936495787
## 2   10 2447272 2653771 2501385 11898135371  40946651425   4259443011
## 3   11 1454864 1733497 1492293  8766590353  77227999502   6058939443
## 4   12 1610511 2066415 1625575  6380264226 207437211253   6091328951
## 5   13 1677556 1452199 1639576  8463151804  52254724857   6499476677
## 6   14 2675051 2612459 2646166 10661839563   4020811294  -1566944835
## 7   15 5025055 4847789 4922914 50021689503  15540601912  -7759801492
## 8   16 2707267 2588445 2651713 11824966680  12195104451    835591075
## 9   17 2055552 2275814 2099965  8768602052  49497901719   4053082455
## 10  18 1807191 1717882 1763790  7632632319   6568065643    340157461
## 11  19 1875708 2259356 1900670  8542732824 147977533025   7305309181
## 12   2 1616163 1471233 1569184  7347192758  20146336217   3454142587
## 13  20 1939387 1536300 1897193 16970122572 159631587925  15092022839
## 14  21 1524842 1868563 1545711  6265088987 118367769430   5661302001
## 15  22 2025354 1855099 1983748  7098752350  26865976390   4375650473
## 16  23 2137048 2554785 2159743  8607852055 174155528253   7975423198
## 17  24 2705014 2686575 2683550 14384172251  -3854887807  -6075549386
## 18  25 3916253 3707607 3820868 27320658717  32515197077   5625125042
## 19  26 2038781 2253027 2072714  6801606592  45645765308   4771440021
## 20  27 1852340 1378899 1837245  7238479013 222416315291   6982867612
## 21  28 1622965 1897561 1654284  7544241092  73987484248   6131199558
## 22  29 1938588 2049217 1994395  9751086600   6951051587   -316647031
## 23   3 1780209 1896239 1816737 11810941037  12705726293  -2312223131
## 24   4 2297735 2443800 2357458 17988199005  17460719151  -2937571684
## 25   5 2077302 1901315 2024670 10083301538  31486735280   5330846164
## 26   6 2536384 2123836 2494966 16577925967 169369349866  14778675785
## 27   7 2715204 3047707 2745605  9297420178 107670084293   8218830092
## 28  71 2298738 2306208 2292298 25188971593  -5799966983 -11196057732
## 29  72 1855747 2074494 1907670 22244149141  47749585226  -2709555480
## 30  73 3481010 3089367 3392807 31796826493 149084786452  22539932173
## 31  74 2205340 2081860 2153763  9766068708  14468000069   1586470971
## 32  75 1863324 2152664 1917845 14037600435  82987084674   7694398934
## 33  76 2094169 1991805 2030468 22069169268   9813482478  -1974539650
## 34  77 2246969 2220291 2220281 28816551894   -973369783  -9214219261
## 35  78 7017355 6949227 6949227 87430705924 -75946938489 -75946938489
## 36  79 2172494 2005499 2109906 13674581772  25910380136   4467562995
## 37   8 2020552 1755585 1980542  9980441811  69472496352   8264653618
## 38   9 2277091 2233868 2254849  8028505580   2107739918  -1403313198
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         5054.848      15992.6173       2341.6515    2.78185563
## 2         4826.351      15448.5322       1795.5363    3.44143432
## 3         5918.330      44511.4105       4093.7872    8.80935420
## 4         3923.647     100395.9020       3713.6313   32.51232298
## 5         4958.947      36239.9434       3847.4419    6.17438114
## 6         3959.895       1541.1623       -639.5605    0.37712172
## 7         9877.880       3132.0685      -1755.4006    0.31067727
## 8         4343.312       4703.8226        236.4445    1.03130138
## 9         4224.204      21729.7939       2010.4514    5.64490228
## 10        4193.002       3850.1387        112.4217    0.86052431
## 11        4501.430      65472.3666       3842.0644   17.32203688
## 12        4514.789      13875.9141       2105.1474    2.74204542
## 13        8607.677     103944.8633       7807.9709    9.40662551
## 14        4053.073      63304.3449       3623.5975   18.89323036
## 15        3488.526      14524.8162       2160.2744    3.78460539
## 16        4002.034      68068.1873       3674.6801   20.23217025
## 17        5246.842      -1408.1622      -2232.4875   -0.26799511
## 18        6949.845       8784.8561       1364.0212    1.19013225
## 19        3323.340      20161.9898       2328.3377    6.71102697
## 20        3852.309     161628.7602       3749.9937   30.72694069
## 21        4613.722      38928.6126       3715.6690    9.80714738
## 22        4946.724       3353.8346       -106.1655    0.71284892
## 23        6531.527       6675.9638      -1091.0725    1.07575901
## 24        7729.826       7156.4856      -1060.5089    0.97067634
## 25        4805.869      16644.2923       2519.5409    3.12266128
## 26        6469.819      79679.1352       5847.9150   10.21655846
## 27        3411.106      35187.1346       2987.5168   11.58064089
## 28       10749.895      -2501.0049      -4829.3559   -0.23025819
## 29       11576.491      23036.0819       -848.1507    2.14661325
## 30        9072.067      48176.3951       6481.8160    4.68866874
## 31        4403.924       6997.5668        644.7300    1.48145590
## 32        7446.232      38443.3669       4176.5459    5.91177139
## 33       10329.443       4915.4679      -1191.4035    0.44466932
## 34       12538.078       -428.7044      -4194.4590   -0.03377815
## 35       12419.512     -10923.6149     -10923.6149   -0.86865293
## 36        6233.696      13032.2592       1973.2283    1.89478410
## 37        4898.261      39780.1565       4115.9114    6.96086382
## 38        3506.259        977.8681       -647.3112    0.26253204
##    Efisiensi_com
## 1     0.46870270
## 2     0.35799248
## 3     0.69113979
## 4     0.95471421
## 5     0.76797354
## 6    -0.14696759
## 7    -0.15512874
## 8     0.07066329
## 9     0.46222675
## 10    0.04456621
## 11    0.85514897
## 12    0.47013093
## 13    0.88932904
## 14    0.90362675
## 15    0.61639712
## 16    0.92652884
## 17   -0.42237741
## 18    0.20589273
## 19    0.70151661
## 20    0.96468714
## 21    0.81269931
## 22   -0.03247300
## 23   -0.19576959
## 24   -0.16330549
## 25    0.52868063
## 26    0.89146711
## 27    0.88399039
## 28   -0.44448253
## 29   -0.12180981
## 30    0.70887364
## 31    0.16244725
## 32    0.54812779
## 33   -0.08947050
## 34   -0.31975440
## 35   -0.86865293
## 36    0.32670564
## 37    0.82808495
## 38   -0.17479133

Rata-rata efisiensi:

rt_syn_1_0.3 <- mean(res_srs_0.3$Efisiensi_syn)
rt_com_1_0.3 <- mean(res_srs_0.3$Efisiensi_com)
rt_syn_1_0.3
## [1] 6.127096
rt_com_1_0.3
## [1] 0.3396666
      i. f = 20%
res_srs_0.2
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1636202 1481666 1574166  14572545244   23375797723    4510695163
## 2   10 2446665 2652868 2510919  20001752276   39537388743    1453890787
## 3   11 1417673 1729914 1464111  12816346281   97321023636    7310525358
## 4   12 1616938 2061117 1644337  10762754056  197623934948    9695545677
## 5   13 1635462 1438544 1579923  12733635533   39445221817    7198910503
## 6   14 2673866 2610873 2632046  16602009048    5554512554   -1595558742
## 7   15 5085111 4863610 4930522  88623745643    -277664980  -21287175995
## 8   16 2703177 2597244 2646103  19636376252   13280476485     191061757
## 9   17 2084702 2278620 2138334  15320312578   36930800196    1636683593
## 10  18 1788705 1719188 1755279  12943817775    5903202221   -2871618240
## 11  19 1890455 2265483 1937840  15222832622  138858072176   10957859005
## 12   2 1636162 1472639 1579239  12755913040   29443828181    4300926069
## 13  20 1904382 1536712 1833476  26216597936  133900472516   20643295867
## 14  21 1549447 1868566 1588839  11537995417  101595669380    7922607721
## 15  22 2027927 1859389 1968143  12275742962   25612929788    4378745585
## 16  23 2139092 2560774 2178862  14975880969  176142401483   12549829518
## 17  24 2684891 2696039 2674266  27119655841   -8105361463  -13451983753
## 18  25 3941422 3720543 3807658  47438228161   23203015866    1624625337
## 19  26 2031133 2241181 2077945  11132858176   44784375206    4137525345
## 20  27 1840008 1354789 1816731  11418601491  231713897129   10769257838
## 21  28 1610492 1878695 1660674  12396717677   68666160643    7265618045
## 22  29 1931315 2026521 1994606  16174169563   -2741587051   -6731449670
## 23   3 1784157 1893897 1817651  21400938990    8253873734   -8497938778
## 24   4 2319251 2446761 2348296  35058309618   14070016899  -15758814917
## 25   5 2090102 1896221 2012878  18116413384   34535696139    6776819947
## 26   6 2524980 2122393 2456265  27558232708  156766471309   21506968557
## 27   7 2693459 3046031 2741129  15456068590  120151376283   11698421032
## 28  71 2296368 2309874 2294108  40205739987   -9535895606  -17340577086
## 29  72 1874180 2077123 1915615  42091333916   41750474571  -16566158651
## 30  73 3500473 3092016 3381825  54628848415  160917314383   29019793679
## 31  74 2205154 2083299 2150929  15583358454   16708291356     932927208
## 32  75 1861248 2156380 1936815  24740361743   84292512765    5800524176
## 33  76 2089428 1994162 2021695  37673504866   -1601863836  -11202807862
## 34  77 2233458 2223572 2209788  44814192212   -3379055899  -17195119769
## 35  78 6985679 6948383 6948383 152322296477 -141277641818 -141277641818
## 36  79 2160215 2008181 2086963  24287997701   21382356313    1554191917
## 37   8 2014679 1753451 1950259  16906371134   65813537237   11197728992
## 38   9 2282664 2224002 2239099  14175749991   -2519404557   -4854764312
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         8652.927      15992.2491      2568.58762   1.604098483
## 2         8054.468      14973.4429       831.78315   1.976696251
## 3         8810.268      56169.4110      5129.45363   7.593507658
## 4         6589.613      95622.1674      5861.28432  18.361836934
## 5         7603.301      27944.0685      4333.42150   3.097718771
## 6         6150.133       2153.5329      -640.33769   0.334568698
## 7        17293.798       -179.4467     -4600.59522  -0.003133077
## 8         7174.811       5111.4389       -48.90101   0.676320127
## 9         7261.415      16185.3248       991.87113   2.410577461
## 10        7151.400       3553.8524     -1770.53071   0.456063452
## 11        7908.498      61249.3685      5663.86836   9.121697363
## 12        7664.719      20164.2657      2438.27701   2.308249366
## 13       13365.170      87371.7538     10816.74580   5.107469430
## 14        7305.425      54378.4744      5061.74562   8.805313723
## 15        6002.197      13974.4705      2110.59962   2.086466772
## 16        6942.762      68682.4296      5765.29618  11.761738882
## 17        9757.869      -2966.8259     -4883.17453  -0.298874053
## 18       11957.781       6207.6881       225.05724   0.489120626
## 19        5445.168      19912.4387      2134.44121   4.022720356
## 20        6094.335     171668.3411      5833.50698  20.292668705
## 21        7611.914      36418.1351      4501.27263   5.539059809
## 22        8155.034      -1285.4367     -3215.94479  -0.169504038
## 23       11661.067       4443.8376     -4238.70682   0.385678111
## 24       14651.390       5818.2094     -6186.75875   0.401331868
## 25        8537.517      18344.7033      3122.42317   1.906320827
## 26       10753.874      74008.8764      8521.68342   5.688553144
## 27        5705.146      39116.4959      4296.35845   7.773734671
## 28       16992.632      -4082.0864     -7474.89505  -0.237177468
## 29       20951.851      20508.9916     -7179.62727   0.991901912
## 30       15415.309      51806.5876      8084.18280   2.945647200
## 31        7001.616       8143.8169       273.94128   1.072188091
## 32       13003.567      39077.0338      3565.98738   3.407084894
## 33       17539.763       -757.9501     -5822.07316  -0.042519639
## 34       19440.603      -1434.5497     -7724.08631  -0.075401468
## 35       21697.415     -20248.4403    -20248.44029  -0.927491543
## 36       11043.118      10861.2275       433.82597   0.880367191
## 37        8259.027      37701.8872      5538.10359   3.892824588
## 38        6139.166      -1092.3194     -2174.99516  -0.177726368
##    Efisiensi_com
## 1    0.309533790
## 2    0.072688171
## 3    0.570406354
## 4    0.900842445
## 5    0.565346046
## 6   -0.096106365
## 7   -0.240197205
## 8    0.009729991
## 9    0.106830953
## 10  -0.221852493
## 11   0.719830486
## 12   0.337171166
## 13   0.787413223
## 14   0.686653741
## 15   0.356699028
## 16   0.838002755
## 17  -0.496023395
## 18   0.034247176
## 19   0.371649875
## 20   0.943132821
## 21   0.586092080
## 22  -0.416185180
## 23  -0.397082520
## 24  -0.449502988
## 25   0.374070728
## 26   0.780419005
## 27   0.756882060
## 28  -0.431296056
## 29  -0.393576471
## 30   0.531217379
## 31   0.059866890
## 32   0.234455916
## 33  -0.297365692
## 34  -0.383698086
## 35  -0.927491543
## 36   0.063990121
## 37   0.662337819
## 38  -0.342469662

Rata-rata efisiensi:

rt_syn_1_0.2 <- mean(res_srs_0.2$Efisiensi_syn)
rt_com_1_0.2 <- mean(res_srs_0.2$Efisiensi_com)
rt_syn_1_0.2
## [1] 3.512097
rt_com_1_0.2
## [1] 0.1728069
      j. f = 10%
res_srs_0.1
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1651737 1475670 1570203  34192283666   29226622341     777346398
## 2   10 2456110 2642080 2520886  46315363403   29632293197  -10363913639
## 3   11 1442237 1723227 1504226  33338750410   74057646378   -6531658292
## 4   12 1596365 2049804 1654510  23562803397  203210736995   15511830205
## 5   13 1663225 1444868 1564719  31735802158   43705859338    8519796158
## 6   14 2653677 2607601 2618875  38276980280    4947428856   -8778691672
## 7   15 5109561 4841286 4918300 200453584817  -24785224131  -57703165129
## 8   16 2692387 2585466 2623827  44356568288    3857899326  -11454409999
## 9   17 2037823 2269626 2119896  33210569697   51587613986   -2445295107
## 10  18 1779507 1710482 1727518  27499744705     875914364   -6325947774
## 11  19 1888606 2250105 1958467  34509820648  136030059713    2106387007
## 12   2 1613718 1463547 1539025  27968584075   20967428996    1297443724
## 13  20 1920884 1527194 1779249  64932688501  146955685741   33209767049
## 14  21 1512527 1855415 1574961  23920546731  120015174097    8020644839
## 15  22 2016962 1853833 1936349  27108579913   22175758238    2451149647
## 16  23 2145624 2551191 2232492  32304043717  161828962012   16879323798
## 17  24 2711322 2701713 2681857  60865777169  -10199617776  -25184913836
## 18  25 3896691 3712241 3769877 103774964093    2141792796  -27353531696
## 19  26 2027224 2231518 2108429  25115934530   37337374387     319018396
## 20  27 1835198 1361115 1784323  24855907783  221225927943   21328589358
## 21  28 1615265 1877334 1690189  27762762152   65093761913    1114974784
## 22  29 1936066 2031757 1998327  36508903327  -15369169758  -20753670621
## 23   3 1814353 1881559 1798453  56046873210    5897620170  -21112110543
## 24   4 2277054 2432404 2311629  74688513919   11624314881  -35143769112
## 25   5 2085644 1887112 1977886  44018781586   28354723727    3089822212
## 26   6 2515348 2107882 2382738  63894087092  156037248043   35880704003
## 27   7 2675396 3048719 2768301  32707486138  123796580890   17880168207
## 28  71 2250029 2293986 2242431  81834232211  -16014638276  -33518784607
## 29  72 1841602 2060501 1876987  97052474214   27155255746  -48653077137
## 30  73 3516720 3069322 3324150 125593321784  197204731926   31398788954
## 31  74 2193817 2068142 2115344  36769038865    6905234530   -8472232472
## 32  75 1828400 2140212 1907222  55353149538   95357118833    -874367249
## 33  76 2105634 1978184 2004142  87618226192    3339220594  -20717886993
## 34  77 2162940 2205912 2156337  90931091100    2368483178  -27772610145
## 35  78 6920687 6893963 6893963 329813291988 -309486530047 -309486530047
## 36  79 2149536 1992501 2053998  45019414856   14695621735   -9067781290
## 37   8 1979416 1749237 1885808  34394179861   52535675767   10427803335
## 38   9 2277855 2220438 2241660  29463295232   -1290796653   -9830978126
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         19739.10      20662.3796       -376.1528    0.85477246
## 2         18413.74      11136.8196      -3458.1664    0.63979403
## 3         21703.46      42972.7715      -2583.9068    2.22136839
## 4         14405.41      98761.7387       9529.9891    8.62421731
## 5         18215.42      31439.0993       4651.1567    1.37717834
## 6         13989.84       2017.4371      -3478.6762    0.12925337
## 7         38239.17      -5407.9434     -12463.2333   -0.12364570
## 8         16169.79       1506.7468      -4642.9242    0.08697470
## 9         15881.77      22843.0619       -528.8738    1.55334926
## 10        15128.73        509.5338      -3850.9173    0.03185173
## 11        17424.57      60537.9830       2105.8022    3.94177823
## 12        16900.52      14862.8669        317.3446    0.74967789
## 13        31914.12      95929.9972      16359.4015    2.26320039
## 14        15235.99      64134.2898       5653.0059    5.01724210
## 15        13213.55      12177.1580        932.0253    0.81803467
## 16        14905.10      63066.1951       7969.4885    5.00955742
## 17        21353.73      -3525.1016      -9120.5824   -0.16757558
## 18        26151.28        855.1480      -7554.5087    0.02063882
## 19        12284.16      16043.6599        500.3411    1.48660104
## 20        12948.84     163937.0178      11483.7636    8.90033588
## 21        16705.29      34580.7754       1517.3724    2.34464285
## 22        17774.68      -6781.8557      -9309.0462   -0.42097046
## 23        28723.93       3055.8275     -10795.4545    0.10522657
## 24        30772.67       4915.1246     -13847.5418    0.15563725
## 25        20477.66      15114.8814        823.4373    0.64415058
## 26        24444.36      74094.4216      13902.3817    2.44212344
## 27        12078.70      40414.0959       6654.4898    3.78496166
## 28        34038.20      -6925.1883     -14384.1450   -0.19569608
## 29        47181.80      13857.9191     -21798.0032    0.27979973
## 30        34831.90      63337.9128       7550.8140    1.57018486
## 31        16512.41       3635.8604      -4276.7929    0.18780025
## 32        28937.74      44231.9922       1296.8889    1.72270448
## 33        39122.34       1844.4373     -11160.5048    0.03811103
## 34        38893.95       1303.3289     -12522.1218    0.02604701
## 35        47141.29     -44496.7245     -44496.7245   -0.93836888
## 36        20367.69       7567.8190      -5026.7690    0.32642854
## 37        16669.84      30422.4343       4798.5076    1.52745831
## 38        12619.41       -390.4486      -4432.5922   -0.04381033
##    Efisiensi_com
## 1     0.02273456
## 2    -0.22376838
## 3    -0.19591791
## 4     0.65831853
## 5     0.26846009
## 6    -0.22934651
## 7    -0.28786297
## 8    -0.25823481
## 9    -0.07363003
## 10   -0.23003660
## 11    0.06103732
## 12    0.04638932
## 13    0.51144913
## 14    0.33530358
## 15    0.09041970
## 16    0.52251427
## 17   -0.41377791
## 18   -0.26358508
## 19    0.01270183
## 20    0.85808933
## 21    0.04016080
## 22   -0.56845505
## 23   -0.37668668
## 24   -0.47053780
## 25    0.07019327
## 26    0.56156533
## 27    0.54666898
## 28   -0.40959368
## 29   -0.50130692
## 30    0.25000365
## 31   -0.23041757
## 32   -0.01579616
## 33   -0.23645636
## 34   -0.30542480
## 35   -0.93836888
## 36   -0.20141935
## 37    0.30318511
## 38   -0.33366866

Rata-rata efisiensi:

rt_syn_1_0.1 <- mean(res_srs_0.1$Efisiensi_syn)
rt_com_1_0.1 <- mean(res_srs_0.1$Efisiensi_com)
rt_syn_1_0.1
## [1] 1.499764
rt_com_1_0.1
## [1] -0.0422394
      k. f = 5%
res_srs_0.05
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1605266 1444798 1519734  58544128587   24483004818   -9143978370
## 2   10 2462822 2632037 2504598  94631985375   11224815540  -44245567336
## 3   11 1424771 1701439 1466087  67132805488   84446965486  -19432824785
## 4   12 1613137 2033371 1708690  52966402143  172559686576    -729282937
## 5   13 1672546 1428623 1542466  73328298941   48330252720    5276930961
## 6   14 2612636 2595422 2587155  82475762200   -8179109573  -32193055568
## 7   15 5084982 4827410 4865063 426028285126  -94322081214 -157041663721
## 8   16 2631731 2558517 2575973  80173336652   -1674125976  -22630861992
## 9   17 1970492 2248021 2044542  62040838795   75508884776  -12430911908
## 10  18 1741692 1685909 1680696  61122287360     914024999  -16592785919
## 11  19 1823223 2224414 1920313  56995747177  152532009473   -1216407695
## 12   2 1592739 1437274 1490567  62124812253    9266140806  -12035724250
## 13  20 1895380 1499794 1713055 127264054064  150620242650   43931761962
## 14  21 1575244 1834821 1641349  62539789837   62521945852  -20015900535
## 15  22 2007998 1827237 1905150  56645253446   30390993570    -815528941
## 16  23 2091849 2526882 2208117  64875716342  187159769968    3721250199
## 17  24 2739948 2667196 2664805 156446147603  -39555990805  -63129077356
## 18  25 3832270 3685580 3725212 204316258330  -20183432612  -68038404648
## 19  26 2014974 2223904 2092473  51282434558   36005645273  -12967648560
## 20  27 1800823 1353262 1687427  54829146153  177109492390   32250623387
## 21  28 1578328 1875851 1675180  60763680394   79088290607  -13514469347
## 22  29 1970406 2052446 2013068  89633369826  -52940777379  -66650943258
## 23   3 1739149 1861027 1730720 103966156668   19456254744  -35664258514
## 24   4 2276095 2413918 2294283 150987701858   36442318888  -45274744050
## 25   5 2058514 1871575 1932698  83874427015   29361561471   -3070414305
## 26   6 2492470 2095351 2294305 131097356477  138651722005   28904171394
## 27   7 2693570 3037439 2824569  76188196052   93327856843   -8402100392
## 28  71 2239970 2266304 2187826 188289808885  -47237510147  -92755978577
## 29  72 1850260 2032304 1855062 207324621400  -18569425390 -109557395746
## 30  73 3437453 3062068 3213476 261062860658  108872563472  -27958522779
## 31  74 2225857 2041748 2105819  82092286992   18165477392   -9462783957
## 32  75 1787210 2111090 1859828 111059477662  116975858156  -28055197176
## 33  76 2104429 1949337 1971412 182747167146    8829393007  -31597377767
## 34  77 2184151 2179412 2107761 219245561388    3791637613  -57363044820
## 35  78 7003672 6950964 6950964 713049902144 -671669893959 -671669893959
## 36  79 2079220 1963674 1980476  99833494950    -253249742  -25896974670
## 37   8 1954082 1726467 1823088  77807965279   47682759321    5811861106
## 38   9 2275690 2218162 2225243  64497901700   -9413374303  -22603379369
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         34127.81      18676.3383       -7126.376   0.418197442
## 2         36404.00       4642.7316      -16012.052   0.118615450
## 3         40505.52      48752.2415       -9387.064   1.257909078
## 4         30681.84      85368.7364        2628.077   3.257908402
## 5         39345.16      35752.5430        1422.714   0.659094148
## 6         30486.48      -3175.0914      -12413.589  -0.099169857
## 7         79033.91     -20799.0088      -33690.544  -0.221398636
## 8         29341.92       -797.6624       -9185.976  -0.020881331
## 9         29786.90      33144.7965       -4187.285   1.217083557
## 10        32618.79        666.3206       -9913.230   0.014954038
## 11        29430.29      68486.5105        1565.684   2.676199840
## 12        36957.39       7559.8574       -9094.253   0.149153623
## 13        58813.39     101790.4327       20639.912   1.183525417
## 14        36289.49      34075.3533       -9313.874   0.999714678
## 15        27114.35      17379.4008       -1108.211   0.536514389
## 16        29957.10      73458.5021        3501.117   2.884897162
## 17        50393.47     -12922.3841      -22074.439  -0.252840939
## 18        51357.26      -5843.6689      -18984.606  -0.098785250
## 19        24781.73      15207.5560       -5268.220   0.702104835
## 20        28133.52     137630.5449       18140.247   3.230207012
## 21        35790.52      41928.1531       -5412.477   1.301571763
## 22        41056.78     -23004.2364      -29158.332  -0.590636919
## 23        51480.52      10335.4057      -18074.963   0.187140271
## 24        57062.46      14811.4715      -18425.125   0.241359518
## 25        37690.59      15730.3055       -3060.940   0.350065717
## 26        49739.73      66713.5508        9288.565   1.057624087
## 27        27509.22      30307.6553       -1668.890   1.224964780
## 28        75482.23     -20033.9600      -39642.451  -0.250876616
## 29        91661.67      -8128.8064      -50428.249  -0.089566908
## 30        71546.48      34599.7162      -12850.129   0.417035817
## 31        35700.41       9792.8954       -5303.750   0.221281171
## 32        56392.73      54222.3707      -10628.731   1.053272180
## 33        75696.99       5051.4700      -17727.823   0.048314801
## 34        84396.32       2637.8285      -25097.417   0.017294022
## 35        99523.17     -94660.8232      -94660.823  -0.941967585
## 36        44541.03        287.0298      -13482.018  -0.002536721
## 37        36969.47      28736.3044        1904.149   0.612826195
## 38        27382.84      -4281.1095      -10133.881  -0.145948536
##    Efisiensi_com
## 1    -0.15618950
## 2    -0.46755404
## 3    -0.28946838
## 4    -0.01376878
## 5     0.07196309
## 6    -0.39033353
## 7    -0.36861793
## 8    -0.28227417
## 9    -0.20036660
## 10   -0.27146867
## 11   -0.02134208
## 12   -0.19373458
## 13    0.34520165
## 14   -0.32005065
## 15   -0.01439713
## 16    0.05735968
## 17   -0.40351954
## 18   -0.33300534
## 19   -0.25286726
## 20    0.58820218
## 21   -0.22241032
## 22   -0.74359520
## 23   -0.34303719
## 24   -0.29985716
## 25   -0.03660728
## 26    0.22047867
## 27   -0.11028087
## 28   -0.49262347
## 29   -0.52843408
## 30   -0.10709498
## 31   -0.11527007
## 32   -0.25261416
## 33   -0.17290215
## 34   -0.26163834
## 35   -0.94196758
## 36   -0.25940166
## 37    0.07469494
## 38   -0.35045139

Rata-rata efisiensi:

rt_syn_1_0.05 <- mean(res_srs_0.05$Efisiensi_syn)
rt_com_1_0.05 <- mean(res_srs_0.05$Efisiensi_com)
rt_syn_1_0.05
## [1] 0.6137953
rt_com_1_0.05
## [1] -0.2068222
  2. Metode One stage cluster 
      a. f = 100%
res_1sc_1
##    kab   Y dir   Y syn   Y com MSE dir      MSE syn MSE com
## 1    1 1637409 1484546 1637409       0  23367160158       0
## 2   10 2452226 2656398 2452226       0  41686037135       0
## 3   11 1432925 1736676 1432925       0  92264682627       0
## 4   12 1628141 2070386 1628141       0 195581155363       0
## 5   13 1660654 1452773 1660654       0  43214520571       0
## 6   14 2677707 2617885 2677707       0   3578628369       0
## 7   15 5059790 4863519 5059790       0  38522139703       0
## 8   16 2702258 2596479 2702258       0  11189241307       0
## 9   17 2063216 2280593 2063216       0  47252536988       0
## 10  18 1802921 1720645 1802921       0   6769362207       0
## 11  19 1893080 2266122 1893080       0 139160429063       0
## 12   2 1631372 1473225 1631372       0  25010528782       0
## 13  20 1933963 1539654 1933963       0 155479806202       0
## 14  21 1543883 1871616 1543883       0 107408906085       0
## 15  22 2024290 1859814 2024290       0  27052299781       0
## 16  23 2145480 2562473 2145480       0 173883605020       0
## 17  24 2721467 2698896 2721467       0    509476091       0
## 18  25 3923463 3722909 3923463       0  40222101589       0
## 19  26 2049321 2256961 2049321       0  43114400382       0
## 20  27 1850200 1379119 1850200       0 221917551646       0
## 21  28 1632444 1899669 1632444       0  71409379673       0
## 22  29 1945828 2049705 1945828       0  10790438814       0
## 23   3 1794553 1899490 1794553       0  11011912392       0
## 24   4 2297582 2449242 2297582       0  23000653140       0
## 25   5 2083579 1902456 2083579       0  32805645589       0
## 26   6 2526531 2124414 2526531       0 161698161955       0
## 27   7 2716794 3050885 2716794       0 111616270475       0
## 28  71 2297609 2314435 2297609       0    283139160       0
## 29  72 1872873 2081921 1872873       0  43701295609       0
## 30  73 3484448 3097221 3484448       0 149945060415       0
## 31  74 2197198 2088987 2197198       0  11709568505       0
## 32  75 1867766 2160606 1867766       0  85755048745       0
## 33  76 2088732 1998934 2088732       0   8063635637       0
## 34  77 2275392 2228054 2275392       0   2240872147       0
## 35  78 7020112 6960868 7020112       0   3509873670       0
## 36  79 2178314 2012520 2178314       0  27487633079       0
## 37   8 2025630 1758243 2025630       0  71496025026       0
## 38   9 2279804 2230617 2279804       0   2419373518       0
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1                0      15740.2769               0           Inf
## 2                0      15692.6939               0           Inf
## 3                0      53127.1634               0           Inf
## 4                0      94466.0213               0           Inf
## 5                0      29746.2278               0           Inf
## 6                0       1366.9922               0           Inf
## 7                0       7920.6305               0           Inf
## 8                0       4309.3906               0           Inf
## 9                0      20719.4082               0           Inf
## 10               0       3934.2014               0           Inf
## 11               0      61409.0701               0           Inf
## 12               0      16976.7190               0           Inf
## 13               0     100983.6028               0           Inf
## 14               0      57388.3367               0           Inf
## 15               0      14545.7042               0           Inf
## 16               0      67857.7295               0           Inf
## 17               0        188.7721               0           Inf
## 18               0      10803.9457               0           Inf
## 19               0      19102.8585               0           Inf
## 20               0     160912.5386               0           Inf
## 21               0      37590.4229               0           Inf
## 22               0       5264.3865               0           Inf
## 23               0       5797.2981               0           Inf
## 24               0       9390.9274               0           Inf
## 25               0      17243.8418               0           Inf
## 26               0      76114.2496               0           Inf
## 27               0      36584.8880               0           Inf
## 28               0        122.3362               0           Inf
## 29               0      20990.8477               0           Inf
## 30               0      48412.7746               0           Inf
## 31               0       5605.3812               0           Inf
## 32               0      39690.2743               0           Inf
## 33               0       4033.9683               0           Inf
## 34               0       1005.7531               0           Inf
## 35               0        504.2293               0           Inf
## 36               0      13658.3135               0           Inf
## 37               0      40663.3405               0           Inf
## 38               0       1084.6208               0           Inf
##    Efisiensi_com
## 1            NaN
## 2            NaN
## 3            NaN
## 4            NaN
## 5            NaN
## 6            NaN
## 7            NaN
## 8            NaN
## 9            NaN
## 10           NaN
## 11           NaN
## 12           NaN
## 13           NaN
## 14           NaN
## 15           NaN
## 16           NaN
## 17           NaN
## 18           NaN
## 19           NaN
## 20           NaN
## 21           NaN
## 22           NaN
## 23           NaN
## 24           NaN
## 25           NaN
## 26           NaN
## 27           NaN
## 28           NaN
## 29           NaN
## 30           NaN
## 31           NaN
## 32           NaN
## 33           NaN
## 34           NaN
## 35           NaN
## 36           NaN
## 37           NaN
## 38           NaN

Rata-rata efisiensi:

rt_syn_2_1 <- mean(res_1sc_1$Efisiensi_syn)
rt_com_2_1 <- mean(res_1sc_1$Efisiensi_com)
rt_syn_2_1
## [1] Inf
rt_com_2_1
## [1] NaN
      b. f = 90%
res_1sc_0.9
##    kab   Y dir   Y syn   Y com     MSE dir      MSE syn      MSE com
## 1    1 1630245 1476800 1623657   967558390  23800101347    922251410
## 2   10 2451728 2645514 2456531   905334100  37494462357    881443930
## 3   11 1427724 1726411 1430535   828155147  89114768750    820052937
## 4   12 1633745 2055681 1636022   953912648 177820190655    948654874
## 5   13 1647670 1445834 1644659   602279355  40761648804    593064991
## 6   14 2672073 2605765 2654481  1310790998   4460561496    609477469
## 7   15 5047244 4837242 5004614  8365042828  41513711427   5971354774
## 8   16 2698089 2583709 2689898   853738513  13206230119    777730735
## 9   17 2046559 2270266 2050630   886135802  50123910124    868890880
## 10  18 1804629 1712994 1797522   601033201   8393939597    545177608
## 11  19 1880520 2252404 1882586   761998543 138230529416    757669715
## 12   2 1625254 1466822 1619523   882128747  25011861595    848269125
## 13  20 1907960 1530587 1904889  1155305219 142209884174   1145831291
## 14  21 1545187 1860751 1547639   763535367  99703682390    757379158
## 15  22 2021562 1852325 2016278   874676752  28490579723    846114494
## 16  23 2128727 2549428 2131471  1145093996 176916384461   1137464721
## 17  24 2693096 2687735 2692348  1144501812    275973343   -286035995
## 18  25 3899411 3702676 3866815  6399992446  36927908650   4767617463
## 19  26 2035556 2238883 2042296  1327597596  41073930449   1280221884
## 20  27 1837456 1366614 1835677   837325480 221457194365    834147584
## 21  28 1620293 1883507 1624971  1207763233  69029771724   1185262288
## 22  29 1932028 2034917 1948843  1585722629   9703679099   1263150785
## 23   3 1780090 1887342 1796349  1487842337  11621494006   1146112364
## 24   4 2293830 2435606 2304743  1434998078  19832640776   1304004175
## 25   5 2066918 1892869 2060856  1032472440  30187357473    994933188
## 26   6 2506349 2115166 2502045  1680635216 153382072269   1661910102
## 27   7 2710464 3044015 2713750  1085552196 111068051881   1074579767
## 28  71 2297885 2297114 2293999  2149882186   -211288804   -763774542
## 29  72 1860215 2065059 1871013  2046520226  42313775986   1917886707
## 30  73 3471490 3075500 3460531  4263288906 156096563754   4141144495
## 31  74 2179834 2072384 2172026   775303856  11682366668    699884503
## 32  75 1837016 2143781 1843194  1840192276  94056278315   1800087070
## 33  76 2077261 1982692 2061319  1377032941   8814697398   1010642016
## 34  77 2239860 2210460 2224032  2964797107   1029114995   -358253781
## 35  78 6962747 6913278 6913278 18591946422 -14867037006 -14867037006
## 36  79 2136666 1996717 2129598   938536049  19745138970    885703536
## 37   8 2025481 1750504 2022368   848303426  75887819138    838517320
## 38   9 2262540 2226052 2242999  1412869912   1138650262    149598722
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         592.8180      16168.2711       567.14661   24.59810342
## 2         369.1794      14164.9850       358.76257   41.41505588
## 3         579.5465      51613.0677       572.76334  107.60636954
## 4         583.5449      86496.3583       579.52624  186.41139843
## 5         365.3001      28241.6821       360.36591   67.67897404
## 6         490.4941       1713.3639       226.62458    3.40295402
## 7        1654.8052       8578.5583      1183.16465    4.96276137
## 8         316.3809       5114.4352       288.84598   15.46870608
## 9         432.6223      22073.4192       423.38799   56.56459202
## 10        332.9503       4902.4143       302.88536   13.96585010
## 11        405.0057      61365.0553       402.26675  181.40524102
## 12        542.5369      17059.8441       523.42868   28.35398084
## 13        605.2005      92930.3026       601.19866  123.09291244
## 14        493.7047      53576.2733       488.95796  130.58161639
## 15        432.5348      15398.9067       419.45986   32.57269574
## 16        537.7700      69387.0995       533.50709  154.49944294
## 17        424.8307        106.2330      -105.74611    0.24112967
## 18       1638.8293       9960.6069      1221.57125    5.76999254
## 19        651.8279      18330.7154       626.57786   30.93853934
## 20        455.4352     162110.7776       454.14679  264.48161382
## 21        744.9316      36645.9920       729.01044   57.15505311
## 22        818.8873       4759.5616       648.01151    6.11940507
## 23        834.7718       6151.1305       640.62082    7.81097145
## 24        624.9891       8142.3618       565.65115   13.82067410
## 25        499.1212      15948.4085       482.30139   29.23793052
## 26        669.4820      72544.0349       663.15402   91.26434507
## 27        400.4071      36464.4672       395.88388  102.31479640
## 28        934.4853        -91.4158      -331.66877   -0.09827925
## 29       1097.6514      20495.3019      1023.47829   20.67596276
## 30       1227.5031      50763.5472      1195.95056   36.61411816
## 31        355.6530       5641.8615       321.75563   15.06811371
## 32        999.7080      43867.7808       974.69052   51.11220145
## 33        662.5509       4448.8461       486.61500    6.40122479
## 34       1321.5299        465.5580      -167.90534    0.34711144
## 35       2665.6955      -2151.2603     -2151.26027   -0.79964930
## 36        438.9071       9895.2108       415.37854   21.03823181
## 37        418.5637      43377.2827       414.35956   89.45834333
## 38        623.3980        515.3087        65.31223    0.80591302
##    Efisiensi_com
## 1      0.9531739
## 2      0.9736118
## 3      0.9902166
## 4      0.9944882
## 5      0.9847008
## 6      0.4649692
## 7      0.7138463
## 8      0.9109707
## 9      0.9805392
## 10     0.9070674
## 11     0.9943191
## 12     0.9616160
## 13     0.9917996
## 14     0.9919372
## 15     0.9673454
## 16     0.9933374
## 17    -0.2499218
## 18     0.7449411
## 19     0.9643147
## 20     0.9962047
## 21     0.9813697
## 22     0.7965774
## 23     0.7703184
## 24     0.9087149
## 25     0.9636414
## 26     0.9888583
## 27     0.9898923
## 28    -0.3552634
## 29     0.9371452
## 30     0.9713497
## 31     0.9027228
## 32     0.9782060
## 33     0.7339273
## 34    -0.1208359
## 35    -0.7996493
## 36     0.9437075
## 37     0.9884639
## 38     0.1058829

Rata-rata efisiensi:

rt_syn_2_0.9 <- mean(res_1sc_0.9$Efisiensi_syn)
rt_com_2_0.9 <- mean(res_1sc_0.9$Efisiensi_com)
rt_syn_2_0.9
## [1] 53.21996
rt_com_2_0.9
## [1] 0.7609081
      c. f = 80%
res_1sc_0.8
##    kab   Y dir   Y syn   Y com     MSE dir      MSE syn      MSE com
## 1    1 1624312 1471983 1608363  2199618313  23537009539   1911452018
## 2   10 2457058 2647065 2468639  2028526604  36354323302   1879340257
## 3   11 1405915 1722378 1411837  1809129511 100133304429   1771334398
## 4   12 1625649 2048575 1630828  2148033993 178725320771   2120202948
## 5   13 1663682 1446157 1657090  1402146507  47423954044   1357231628
## 6   14 2648726 2610265 2630779  2875560607   1819360486   -241987719
## 7   15 5067949 4846004 4992756 19337153056  44057393488   8324107404
## 8   16 2695027 2584974 2676068  1925149448  12371352754   1308087147
## 9   17 2053979 2271344 2063547  1948816235  47289945613   1847430864
## 10  18 1805098 1710402 1789204  1363874990   8811574268   1028603666
## 11  19 1870100 2247957 1874717  1709564199 142803013723   1687435493
## 12   2 1614713 1462698 1600717  1989578074  22616175172   1777437883
## 13  20 1920657 1524355 1914069  2592773911 157073752032   2548994681
## 14  21 1542085 1855075 1547663  1702658832  97773494533   1670127491
## 15  22 2023139 1854560 2011093  1937416554  28148315324   1785535454
## 16  23 2135366 2551040 2141712  2579077629 172942888870   2537303747
## 17  24 2714173 2701232 2709344  2616127325   1410777708   -462958776
## 18  25 3901898 3711873 3835716 14077719994  31719463430   5995116672
## 19  26 2024313 2232910 2039958  2983561101  43069927853   2703447336
## 20  27 1827896 1361733 1823820  1897236946 216660743875   1880462381
## 21  28 1603463 1877174 1613620  2651155935  74698259687   2540024643
## 22  29 1944249 2031043 1982763  3625216768   5322644115    937990755
## 23   3 1769095 1880219 1798978  3365118156  11571425850   1542143252
## 24   4 2298987 2432988 2326257  3240001926  19176878869   1868610815
## 25   5 2075718 1888985 2062542  2332452614  34916741135   2149158673
## 26   6 2495695 2111690 2485685  3836790637 147057898259   3735075624
## 27   7 2716348 3057822 2723686  2461214769 115831231250   2405525410
## 28  71 2299056 2288740 2290120  4888146413  -1687627878  -2519911099
## 29  72 1847757 2054437 1872982  4622309488  41306988691   3858776128
## 30  73 3420435 3067250 3392695  9351140694 122526985950   8545417865
## 31  74 2159206 2062445 2139582  1743723932   9451195384   1158194438
## 32  75 1842447 2134223 1857798  4021511489  86251771500   3740657604
## 33  76 2064658 1971926 2037581  3051573568   8539569218   1242070041
## 34  77 2226812 2200171 2205220  6503347937   1803957492  -1258848895
## 35  78 6965679 6908238 6908238 41447865320 -35318782504 -35318782504
## 36  79 2153013 1986514 2138777  2164382683  28058828790   1939823088
## 37   8 2018219 1748766 2011117  1879192901  73100944228   1827868176
## 38   9 2273591 2230957 2248651  3250183872    809169364   -460457592
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1        1350.9484      16090.1427      1181.97682    10.7004972
## 2         825.0495      13723.2988       761.44607    17.9215413
## 3        1282.5568      58145.9469      1250.62975    55.3488868
## 4        1319.1956      87227.3433      1298.05389    83.2041399
## 5         841.7022      32924.4532       817.90171    33.8223957
## 6        1085.1662        698.7292       -97.88319     0.6326977
## 7        3804.0089       9086.4602      1619.41508     2.2783806
## 8         714.1624       4791.5790       484.13210     6.4261779
## 9         946.9244      20818.7844       893.93666    24.2659850
## 10        755.0746       5158.0088       570.99809     6.4606906
## 11        913.0406      63527.4802       899.05620    83.5318228
## 12       1231.2052      15489.6152      1107.76706    11.3673223
## 13       1348.2365     103119.2664      1329.94310    60.5813532
## 14       1102.6825      52690.7634      1077.84047    57.4240081
## 15        956.3148      15202.4730       885.97596    14.5287885
## 16       1206.9191      67762.4060      1183.96126    67.0561006
## 17        963.0585        532.4699      -169.90657     0.5392619
## 18       3594.5893       8516.5346      1506.03106     2.2531677
## 19       1472.0844      19259.5003      1325.57289    14.4357452
## 20       1036.5991     159270.3945      1029.73723   114.1980417
## 21       1650.8250      39793.3742      1572.56683    28.1757322
## 22       1855.5713       2601.6811       482.08243     1.4682278
## 23       1898.8699       6155.4182       881.83983     3.4386388
## 24       1405.8835       7867.0947       815.40783     5.9187863
## 25       1121.4501      18489.2432      1038.72536    14.9699681
## 26       1532.7818      69631.3537      1498.07213    38.3283614
## 27        905.5324      37828.8914       882.67695    47.0626264
## 28       2121.3980       -734.6031     -1100.75138    -0.3452490
## 29       2492.0100      20106.0393      2060.26281     8.9364394
## 30       2730.5765      39977.8772      2513.04586    13.1028919
## 31        807.4201       4600.8014       536.89133     5.4201214
## 32       2165.1767      40434.6577      1998.97471    21.4476004
## 33       1476.4304       4340.3717       591.51811     2.7984150
## 34       2905.6577        822.6824      -579.76596     0.2773890
## 35       5929.7051      -5101.9597     -5101.95972    -0.8521255
## 36       1003.9985      14159.9282       904.14135    12.9638945
## 37        929.6190      41865.3612       907.27607    38.9001811
## 38       1425.1661        374.4022      -208.54310     0.2489611
##    Efisiensi_com
## 1     0.86899259
## 2     0.92645581
## 3     0.97910867
## 4     0.98704348
## 5     0.96796706
## 6    -0.08415323
## 7     0.43047223
## 8     0.67947304
## 9     0.94797592
## 10    0.75417738
## 11    0.98705594
## 12    0.89337428
## 13    0.98311491
## 14    0.98089380
## 15    0.92160638
## 16    0.98380278
## 17   -0.17696340
## 18    0.42585850
## 19    0.90611429
## 20    0.99115842
## 21    0.95808195
## 22    0.25874060
## 23    0.45827314
## 24    0.57673139
## 25    0.92141579
## 26    0.97348956
## 27    0.97737322
## 28   -0.51551465
## 29    0.83481561
## 30    0.91383695
## 31    0.66420746
## 32    0.93016211
## 33    0.40702608
## 34   -0.19356936
## 35   -0.85212549
## 36    0.89624774
## 37    0.97268789
## 38   -0.14167124

Rata-rata efisiensi:

rt_syn_2_0.8 <- mean(res_1sc_0.8$Efisiensi_syn)
rt_com_2_0.8 <- mean(res_1sc_0.8$Efisiensi_com)
rt_syn_2_0.8
## [1] 23.92731
rt_com_2_0.8
## [1] 0.6419405
      d. f = 70%
res_1sc_0.7
##    kab   Y dir   Y syn   Y com     MSE dir      MSE syn      MSE com
## 1    1 1608711 1463532 1582774  3690096960  21480182564   2515742775
## 2   10 2450337 2649899 2470022  3477714264  39908535220   3021621231
## 3   11 1432558 1721980 1444308  3209780927  83403425628   3056587939
## 4   12 1626934 2055869 1635853  3727702471 183330759124   3644313220
## 5   13 1640088 1432961 1629004  2210318047  43715951134   2077921088
## 6   14 2668889 2600771 2635790  4945616664   3997881782   -141360276
## 7   15 5064430 4849225 4959395 32496861579  32085421143   6416301959
## 8   16 2700804 2579763 2674183  3353980651  15070631563   1805771743
## 9   17 2032761 2269457 2048544  3363538079  56472783975   3070833752
## 10  18 1806416 1709638 1782310  2332476531   9410844627   1310085084
## 11  19 1878253 2252140 1886263  2896188724 139752852921   2828121933
## 12   2 1621438 1463028 1598060  3383067725  25367002511   2657333388
## 13  20 1913479 1524305 1901983  4407461349 151591972726   4272479779
## 14  21 1543510 1863154 1553101  2937664918 102072464110   2838501938
## 15  22 2013851 1848265 1991948  3310458572  27126256205   2755404022
## 16  23 2114018 2545112 2124402  4354152893 184884733940   4240850035
## 17  24 2692934 2666956 2678250  4493523535   1696687423   -792167767
## 18  25 3865489 3694441 3769826 24652924062  16189896437   2875260168
## 19  26 2032692 2247432 2060323  5064943072  46213722682   4037733290
## 20  27 1831015 1359598 1824290  3170759496 221590912705   3124744088
## 21  28 1625079 1881247 1644909  4722316526  64210547645   4282761684
## 22  29 1914496 2022606 1962755  6025391854   7841493403   1146265595
## 23   3 1791077 1886750 1829715  5809511623   8507956964   -170752836
## 24   4 2302177 2438997 2338644  5512128452  20133155404   1672711542
## 25   5 2049643 1894098 2021864  3874343926  23545133562   3002973960
## 26   6 2516436 2123840 2499504  6593250830 153798835146   6299167039
## 27   7 2701237 3036508 2714020  4111938267 111896902252   3934651482
## 28  71 2306484 2292105 2288082  8316009013   -293559142  -2722390289
## 29  72 1828805 2060546 1867427  7800816132  50912282690   5791184415
## 30  73 3472311 3082352 3426012 16681083601 148637148361  14352916318
## 31  74 2184094 2067007 2159192  2965890717  13754978569   1742420226
## 32  75 1843636 2138204 1870603  6851820027  86358027753   5912093628
## 33  76 2043596 1977117 2013467  5179311732   3882146227   -194784520
## 34  77 2237998 2207137 2208692 11524465598   -156493778  -3669026614
## 35  78 7040191 6982970 6982970 74252788939 -66680215706 -66680215706
## 36  79 2158084 1990844 2134846  3662156088  28769895220   2885273281
## 37   8 2029845 1740709 2018049  3297366826  83983782461   3152547556
## 38   9 2270484 2233717 2245099  5337589633   -321225929  -1506870509
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         2284.238     14845.87391      1560.28454    5.82103473
## 2         1417.578     15053.68127      1225.02487   11.47550724
## 3         2230.659     48415.00045      2107.69044   25.98414893
## 4         2287.621     89116.04283      2224.61519   49.18063085
## 5         1341.941     30723.04059      1269.66428   19.77812704
## 6         1851.456      1533.09736       -73.81089    0.80836871
## 7         6386.966      6598.76298      1213.34737    0.98733907
## 8         1241.111      5865.93472       663.66616    4.49335674
## 9         1648.393     24868.19803      1495.30653   16.78969664
## 10        1289.988      5514.92273       720.74997    4.03470067
## 11        1538.911     62035.04451      1496.62696   48.25405601
## 12        2082.668     17397.95504      1644.82150    7.49822486
## 13        2298.028     99671.11413      2240.67032   34.39439639
## 14        1898.866     54728.06659      1824.05793   34.74612216
## 15        1640.110     14699.80171      1374.30073    8.19410834
## 16        2057.658     72629.63940      1994.73508   42.46170001
## 17        1666.419       652.79301      -298.17412    0.37758508
## 18        6344.631      4369.53361       681.21912    0.65671303
## 19        2486.535     20516.30512      1971.09124    9.12423339
## 20        1725.993    163232.80020      1707.26010   69.88575228
## 21        2900.042     34092.85341      2603.11193   13.59725620
## 22        3120.506      3853.19006       605.68400    1.30140804
## 23        3226.425      4527.61644       -26.29439    1.46448747
## 24        2384.431      8247.22567       754.07981    3.65251927
## 25        1884.441     12439.19614      1470.41582    6.07719243
## 26        2607.751     72576.03996      2507.77915   23.32670774
## 27        1519.287     36775.74815      1447.25537   27.21269022
## 28        3582.714      -112.79792     -1183.68442   -0.03530048
## 29        4232.508     24761.89284      3107.94009    6.52653284
## 30        4797.415     48270.11125      4168.65766    8.91052116
## 31        1357.166      6674.65755       793.04780    4.63772266
## 32        3672.000     40424.62429      3131.35325   12.60366259
## 33        2529.480      1975.96118      -128.18988    0.74954867
## 34        5114.732       -65.34375     -1669.91942   -0.01357927
## 35       10501.046     -9527.62739     -9527.62739   -0.89801631
## 36        1692.799     14499.72739      1337.82619    7.85599918
## 37        1621.720     48337.68872      1558.81113   25.46995433
## 38        2335.087      -131.26220      -674.02144   -0.06018183
##    Efisiensi_com
## 1     0.68175520
## 2     0.86885264
## 3     0.95227307
## 4     0.97762985
## 5     0.94010049
## 6    -0.02858294
## 7     0.19744374
## 8     0.53839659
## 9     0.91297725
## 10    0.56167128
## 11    0.97649781
## 12    0.78548040
## 13    0.96937430
## 14    0.96624428
## 15    0.83233303
## 16    0.97397821
## 17   -0.17629100
## 18    0.11662958
## 19    0.79719224
## 20    0.98548758
## 21    0.90691966
## 22    0.19023918
## 23   -0.02939194
## 24    0.30346019
## 25    0.77509225
## 26    0.95539624
## 27    0.95688486
## 28   -0.32736740
## 29    0.74238186
## 30    0.86043069
## 31    0.58748632
## 32    0.86285010
## 33   -0.03760819
## 34   -0.31836848
## 35   -0.89801631
## 36    0.78786191
## 37    0.95608033
## 38   -0.28231292

Rata-rata efisiensi:

rt_syn_2_0.7 <- mean(res_1sc_0.7$Efisiensi_syn)
rt_com_2_0.7 <- mean(res_1sc_0.7$Efisiensi_com)
rt_syn_2_0.7
## [1] 14.14013
rt_com_2_0.7
## [1] 0.5479332
      e. f = 60%
res_1sc_0.6
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1596830 1462873 1561907   5748600406   19006226065    2919855837
## 2   10 2453780 2640554 2486867   5451677413   33844140666    3758440991
## 3   11 1408747 1717212 1426080   4832188810   95426726123    4467501820
## 4   12 1633631 2045035 1648654   5840302635  168664419810    5588610407
## 5   13 1649960 1435372 1632468   3578287628   46034601083    3241102962
## 6   14 2656859 2600141 2624817   7662383884    3243117519    -798437910
## 7   15 5035380 4836678 4908692  49293215685   14931390953   -3716002002
## 8   16 2697008 2576717 2661591   5097493129   14549027193    2151423955
## 9   17 2042885 2265307 2069621   5199922738   49014067156    4052644106
## 10  18 1801417 1705616 1771144   3596638272    9208897080    1363632548
## 11  19 1872032 2244309 1885315   4652618008  138856938373    4456439130
## 12   2 1616706 1459029 1580807   5200698779   24813764114    3272451762
## 13  20 1932066 1519577 1914796   7026459885  169114264781    6722793977
## 14  21 1542516 1853667 1558454   4573931601   97040568708    4279901897
## 15  22 1991569 1849494 1954505   5159586400   19330697709    3045345572
## 16  23 2126017 2542705 2143480   6884341903  173088285940    6548767480
## 17  24 2704546 2683070 2690811   6710087537     932671015   -1978941277
## 18  25 3901931 3697155 3799556  37678785198   30353576484    4772351025
## 19  26 2013663 2233760 2053188   7708170832   47773557209    4898320453
## 20  27 1820780 1355804 1810193   4909417839  214591585365    4793719141
## 21  28 1610098 1873247 1641369   7174828041   68003713405    5954320663
## 22  29 1921270 2021782 1982728   9056570963    3545007702    -674398632
## 23   3 1760780 1876649 1795435   8522545943   14847840370    -331968157
## 24   4 2287032 2429590 2332465   8623147940   19795703011    1754090919
## 25   5 2067625 1884952 2031700   6203672308   32918736586    4525305922
## 26   6 2492687 2110785 2465906  10050757640  142927877754    9283842465
## 27   7 2688002 3039258 2707207   6378923803  121692891886    5965778436
## 28  71 2295948 2282580 2278161  13421204601   -4095633572   -6280962017
## 29  72 1816565 2049967 1871792  12030466272   55387479068    4459074886
## 30  73 3425704 3064926 3354273  24670414636  125617055656   18048085606
## 31  74 2165353 2057246 2134259   4590980123   13852208063    1419702565
## 32  75 1831418 2128692 1874249  10585275364   85730737276    7958196844
## 33  76 2033239 1967128 2007166   7990667945    6944344344     104979789
## 34  77 2239629 2195800 2206846  17124777211    2127723788   -5375405939
## 35  78 6986886 6925236 6925236 112772563787 -104734805844 -104734805844
## 36  79 2161281 1981300 2128301   5593024783   33208223930    4046793873
## 37   8 2020501 1739305 2001450   5092042994   78744098456    4703216553
## 38   9 2275306 2225128 2237579   8541603621    -371900960   -2510458109
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         3572.626      13196.6921    1.803738e+03    3.30623538
## 2         2218.569      12787.8502    1.526518e+03    6.20802335
## 3         3399.819      55559.0294    3.109586e+03   19.74813690
## 4         3560.198      82419.5603    3.378172e+03   28.87939724
## 5         2160.248      32391.9385    1.976445e+03   12.86498065
## 6         2878.932       1248.7087   -3.260526e+02    0.42325177
## 7         9726.245       3090.7602   -8.781761e+02    0.30290965
## 8         1887.869       5662.7939    7.869431e+02    2.85415337
## 9         2536.785      21608.5077    1.972511e+03    9.42592220
## 10        1992.722       5403.5241    7.378748e+02    2.56041792
## 11        2477.203      61874.2725    2.357718e+03   29.84490413
## 12        3203.939      17072.5024    2.012618e+03    4.77123655
## 13        3626.535     111465.1962    3.499741e+03   24.06820327
## 14        2952.045      52314.7947    2.737727e+03   21.21600784
## 15        2582.231      10504.3543    1.528765e+03    3.74655955
## 16        3232.288      68020.9022    3.052373e+03   25.14231402
## 17        2474.707        373.2870   -7.324836e+02    0.13899536
## 18        9569.181       8139.3233    1.052647e+03    0.80558798
## 19        3812.626      21298.6495    2.426602e+03    6.19778132
## 20        2684.807     158744.3154    2.637113e+03   43.71018976
## 21        4435.408      36358.0257    3.643123e+03    9.47809662
## 22        4651.222       1746.9569   -2.913822e+02    0.39142935
## 23        4793.695       7912.2879   -4.349178e+01    1.74218367
## 24        3750.675       8139.6210    8.159000e+02    2.29564692
## 25        2987.343      17503.7543    2.194423e+03    5.30633066
## 26        4013.255      67801.1303    3.745965e+03   14.22060733
## 27        2367.361      39967.1902    2.199212e+03   19.07733901
## 28        5799.432      -1785.7317   -2.747331e+03   -0.30516140
## 29        6535.175      27108.8065    2.576113e+03    4.60393453
## 30        7174.905      40989.0927    5.287331e+03    5.09180966
## 31        2117.809       6773.1987    6.296349e+02    3.01726596
## 32        5701.549      40316.9601    4.230360e+03    8.09905594
## 33        3911.193       3568.2430   -8.194221e-01    0.86905680
## 34        7560.930        960.6493   -2.502356e+03    0.12424826
## 35       16028.639     -15038.6446   -1.503864e+04   -0.92872594
## 36        2576.112      16826.1184    1.870914e+03    5.93743551
## 37        2515.062      45406.2150    2.341838e+03   15.46414642
## 38        3718.149       -145.8777   -1.128835e+03   -0.04353995
##    Efisiensi_com
## 1     0.50792465
## 2     0.68941001
## 3     0.92452965
## 4     0.95690425
## 5     0.90576927
## 6    -0.10420229
## 7    -0.07538567
## 8     0.42205529
## 9     0.77936622
## 10    0.37914087
## 11    0.95783473
## 12    0.62923309
## 13    0.95678252
## 14    0.93571620
## 15    0.59023056
## 16    0.95125541
## 17   -0.29492034
## 18    0.12665883
## 19    0.63547118
## 20    0.97643332
## 21    0.82989037
## 22   -0.07446512
## 23   -0.03895176
## 24    0.20341654
## 25    0.72945599
## 26    0.92369578
## 27    0.93523275
## 28   -0.46798795
## 29    0.37064855
## 30    0.73156799
## 31    0.30923736
## 32    0.75181765
## 33    0.01313780
## 34   -0.31389640
## 35   -0.92872594
## 36    0.72354299
## 37    0.92364039
## 38   -0.29390946

Rata-rata efisiensi:

rt_syn_2_0.6 <- mean(res_1sc_0.6$Efisiensi_syn)
rt_com_2_0.6 <- mean(res_1sc_0.6$Efisiensi_com)
rt_syn_2_0.6
## [1] 8.964641
rt_com_2_0.6
## [1] 0.4520409
      f. f = 50%
res_1sc_0.5
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1632835 1484396 1587700   9149275272   24710825324    3600460559
## 2   10 2442102 2658680 2484736   7982011652   47442665743    4807211628
## 3   11 1436098 1734481 1465764   7720659809   88823987812    6384506992
## 4   12 1622028 2069503 1642273   8223150817  201419986695    7720955720
## 5   13 1658700 1455429 1632825   5267253894   44493306809    4168586106
## 6   14 2680381 2616552 2654106  11553496906    4394988910   -1907469406
## 7   15 5049364 4865599 4922524  75538502109     211702643  -18050628493
## 8   16 2704944 2594129 2663401   7696106400   12618541482    1450062426
## 9   17 2051418 2278097 2087937   7775100723   52034466309    4643942407
## 10  18 1789562 1717167 1760212   5336973548    5245592723    -104476699
## 11  19 1885847 2261112 1905849   6893154128  140627612789    6421194833
## 12   2 1630842 1468403 1583462   7834424327   24991897061    3923690202
## 13  20 1929203 1536348 1901610  10634835530  151350964943    9844575843
## 14  21 1541598 1866919 1566020   6992767358  106014126401    6233046544
## 15  22 2006537 1851819 1960359   7553923526   23249265268    3707170325
## 16  23 2139990 2559908 2167293  10297389336  176566341195    9380422906
## 17  24 2730352 2695276 2705003  10411215457    2770248296   -2571872059
## 18  25 3931271 3721743 3810568  56823637116   25854402629   -2115114619
## 19  26 2040098 2252817 2097818  12181761255   44783115954    4966525375
## 20  27 1851796 1380423 1836040   7406626495  219999093114    7146902363
## 21  28 1635279 1896860 1683694  11001886098   66936460635    6958205278
## 22  29 1930172 2041215 1994725  13383817835    3472679605   -2724557737
## 23   3 1785951 1898597 1827580  13275318879   12511112390   -1790863735
## 24   4 2289779 2445629 2336206  12587035083   27758580633     380193800
## 25   5 2087316 1902848 2034377   9800476889   32528185002    5535274249
## 26   6 2531720 2122752 2490956  16310014002  161528922618   14520781286
## 27   7 2719634 3062810 2750592   9586691380  116071926073    8428355652
## 28  71 2304420 2313967 2289799  19363750966   -1804806154   -8321759197
## 29  72 1868184 2080171 1931877  18943411549   45095800285     -66996860
## 30  73 3496997 3093098 3397968  38993407097  151112504160   25079083681
## 31  74 2193982 2087575 2155270   7046233853   11323391968    1306409428
## 32  75 1857099 2159343 1922719  17023642203   90505691992    7987323741
## 33  76 2072897 1997407 2032107  11976143554    4774368130   -1801279242
## 34  77 2302002 2226120 2244680  29039513066    -785965586   -7629609260
## 35  78 7010166 6951603 6951603 171393204556 -159075991797 -159075991797
## 36  79 2176669 2011265 2127547   8745647098   29256785951    3872442105
## 37   8 2029909 1759446 1998376   7845808231   72865230246    6669952232
## 38   9 2308347 2235983 2251192  14377199825     182871752   -2930864696
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         5545.196     17091.06986       2140.9449   2.700850569
## 2         3255.867     17809.03687       1972.8303   5.943697881
## 3         5335.778     51137.97638       4376.5082  11.504714624
## 4         5023.250     97324.24144       4667.3643  24.494259097
## 5         3141.983     31164.97839       2508.7194   8.447154382
## 6         4302.623      1702.16457       -767.5090   0.380403349
## 7        14824.919        62.37873      -3825.3771   0.002802579
## 8         2843.400      4879.87548        503.1396   1.639600705
## 9         3760.162     22834.80897       2274.7885   6.692449161
## 10        2975.198      3083.23538       -111.6313   0.982877782
## 11        3637.933     62164.24181       3358.3704  20.401054463
## 12        4784.870     17205.18210       2375.7519   3.190010653
## 13        5482.503     98614.37933       5143.5490  14.231622531
## 14        4499.833     56684.22632       3965.0380  15.160539593
## 15        3739.404     12628.41104       1811.8127   3.077773449
## 16        4793.961     68940.12143       4326.5928  17.146709271
## 17        3800.182      1114.70451       -935.2181   0.266083082
## 18       14282.295      6786.81744       -915.3874   0.454993801
## 19        5932.033     19793.64797       2476.8782   3.676243116
## 20        3972.433    159687.60473       3866.5057  29.703008956
## 21        6681.356     35201.15002       4243.4087   6.084089586
## 22        6812.275      1706.32108      -1264.5876   0.259468535
## 23        7362.256      6560.78390       -794.0801   0.942434039
## 24        5447.706     11314.55422        302.4660   2.205331156
## 25        4662.435     17131.01112       2627.0299   3.319041040
## 26        6403.429     76328.63477       5788.1197   9.903665478
## 27        3509.611     37786.85818       3057.9329  12.107610590
## 28        8273.735      -731.34530      -3567.8244  -0.093205400
## 29        9916.151     21873.69275        372.9404   2.380553269
## 30       11101.486     48799.60290       7172.5296   3.875334715
## 31        3203.388      5444.26846        549.0460   1.607013364
## 32        8981.224     41835.61786       4289.6770   5.316470524
## 33        5747.393      2389.87161       -965.9305   0.398656555
## 34       12485.621      -368.93950      -3506.1763  -0.027065384
## 35       24160.139    -22678.83241     -22678.8324  -0.928134766
## 36        3995.768     14692.34711       1731.9743   3.345296880
## 37        3847.904     41712.67680       3305.7774   9.287154121
## 38        6135.435       141.00458      -1295.4563   0.012719567
##    Efisiensi_com
## 1    0.393524126
## 2    0.602255652
## 3    0.826938001
## 4    0.938929115
## 5    0.791415449
## 6   -0.165098881
## 7   -0.238959312
## 8    0.188415070
## 9    0.597283890
## 10  -0.019576020
## 11   0.931532172
## 12   0.500826869
## 13   0.925691405
## 14   0.891356201
## 15   0.490760902
## 16   0.910951563
## 17  -0.247028992
## 18  -0.037222443
## 19   0.407701749
## 20   0.964933545
## 21   0.632455673
## 22  -0.203571042
## 23  -0.134901749
## 24   0.030205191
## 25   0.564796419
## 26   0.890298517
## 27   0.879172523
## 28  -0.429759669
## 29  -0.003536684
## 30   0.643162154
## 31   0.185405346
## 32   0.469190062
## 33  -0.150405615
## 34  -0.262731997
## 35  -0.928134766
## 36   0.442785086
## 37   0.850129398
## 38  -0.203855044

Rata-rata efisiensi:

rt_syn_2_0.5 <- mean(res_1sc_0.5$Efisiensi_syn)
rt_com_2_0.5 <- mean(res_1sc_0.5$Efisiensi_com)
rt_syn_2_0.5
## [1] 6.055086
rt_com_2_0.5
## [1] 0.3401404
      g. f = 40%
res_1sc_0.4
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1627819 1457220 1574173  13661967555   34882256945    4565449154
## 2   10 2461838 2629777 2519165  12296877279   26860859463    2945015874
## 3   11 1419674 1713898 1466165  11237745018   86036882125    7457872190
## 4   12 1606572 2040026 1638915  12232130719  187245047149   10845897032
## 5   13 1635850 1435009 1595833   7918258386   41924425739    5290756048
## 6   14 2644197 2591303 2617990  16963951147    1300268288   -5385808398
## 7   15 5017904 4816432 4869264 107175050073   16581986340  -18473742859
## 8   16 2705339 2566454 2653327  11771003943   19036493298    2179905111
## 9   17 2013291 2258388 2062783  11715566013   59827946419    6125157821
## 10  18 1793140 1700617 1751254   8046523741    8024159721     711866027
## 11  19 1878358 2236471 1910453  10141971305  127604602508    8868593518
## 12   2 1616477 1455015 1559542  11868938909   25783526211    4084146614
## 13  20 1878523 1515214 1833778  15499838106  131052954627   13307922054
## 14  21 1522444 1848831 1557161   9781414904  106513443687    7935940591
## 15  22 2025466 1846072 1968459  11763347876   31816808551    5048262837
## 16  23 2108607 2533650 2148864  15308600581  179741088359   13400299177
## 17  24 2678137 2676007 2676546  15937303428     857236141   -5996293932
## 18  25 3878452 3683325 3738921  89500331110     321220633  -19305932562
## 19  26 2018850 2233731 2092171  17549488451   41199986615    5096093717
## 20  27 1834772 1361079 1810870  11319350788  219731381881   10704810116
## 21  28 1629138 1872864 1695471  17008645370   57030586125    6486797547
## 22  29 1909741 2013384 1967831  20497924779   -2301559877   -9845662952
## 23   3 1750773 1871027 1795164  19758797405   13986317988   -4617222058
## 24   4 2284572 2421378 2334747  19116386793   18070809933   -3442929190
## 25   5 2049203 1879784 1985531  13857019176   26051595510    4760125030
## 26   6 2503678 2103505 2443507  23564940218  157918808743   19500301823
## 27   7 2698824 3025619 2749747  14763088671  101987505245   11240768977
## 28  71 2293864 2273770 2260326  30341244726   -1887782472  -11091284651
## 29  72 1857247 2042539 1921478  28982832643   32512280889   -3567242128
## 30  73 3410397 3050337 3282343  55793685578  121509303146   21544294127
## 31  74 2157622 2049713 2119084  10300082065   11960958342     108731677
## 32  75 1791985 2120565 1870785  24442831808  100304302157    7868750583
## 33  76 2079564 1959910 2011079  18525023450    9375901021   -1141168013
## 34  77 2210053 2187290 2184401  38559658656   -1336895871  -13580952802
## 35  78 6957154 6896767 6896767 262564863669 -241802782761 -241802782761
## 36  79 2092725 1973719 2038840  12766347717   13953040495    1424347098
## 37   8 2014224 1732895 1971823  11603367125   80493096212    9282824304
## 38   9 2235646 2218540 2214374  18173537620   -6124860175   -8610151417
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         8244.350     25011.03701      2650.32552   2.553238163
## 2         4975.901     10179.28770      1260.06606   2.184364278
## 3         7799.467     50106.92345      5180.70604   7.656062848
## 4         7525.748     91662.74361      6577.08199  15.307639483
## 5         4777.923     29865.75613      3220.74454   5.294652396
## 6         6403.725       530.45127     -2118.47362   0.076648905
## 7        20994.948      3465.31155     -3997.33885   0.154718718
## 8         4351.147      7435.98425       745.96827   1.617236167
## 9         5763.758     26507.17006      3083.16200   5.106705588
## 10        4467.386      4775.58798       333.90653   0.997220661
## 11        5368.412     56975.61997      4637.16631  12.581834307
## 12        7281.371     17874.10037      2408.47425   2.172353098
## 13        8171.598     86724.77969      7145.19034   8.455117642
## 14        6354.523     57403.77199      5103.91157  10.889369763
## 15        5761.753     17466.13067      2435.79040   2.704740936
## 16        7226.562     70873.65966      6234.38119  11.741183487
## 17        5921.521       478.33610     -2216.11100   0.053788029
## 18       22696.452        33.65131     -5533.97534   0.003589044
## 19        8619.476     18087.22241      2589.42499   2.347646014
## 20        6098.801    161763.28509      5846.82735  19.412012755
## 21       10357.749     30306.85466      4149.54014   3.353035170
## 22       10449.586     -1088.77596     -4721.02273  -0.112282580
## 23       11115.809      7467.48932     -2241.20059   0.707852695
## 24        8281.224      7435.33156     -1256.14976   0.945304682
## 25        6710.745     13956.21303      2228.07764   1.880028827
## 26        9261.660     75385.39612      7823.61299   6.701430484
## 27        5447.057     33305.27778      4091.43645   6.908276955
## 28       12947.966      -824.03589     -4872.89044  -0.062218360
## 29       15277.657     16088.65881     -1236.66768   1.121777201
## 30       16208.066     40028.36063      6025.14290   2.177832525
## 31        4768.287      5921.67564       -49.23173   1.161248839
## 32       13285.103     47328.66911      4546.30623   4.103628538
## 33        8867.682      4828.92677      -733.13944   0.506120872
## 34       17193.080      -659.34166     -6255.08683  -0.034670843
## 35       37085.496    -34601.54196    -34601.54196  -0.920925898
## 36        6041.083      7157.60606       587.71592   1.092954759
## 37        5695.723     46803.20305      4609.12934   6.937046406
## 38        7921.615     -2658.37272     -3800.43214  -0.337020799
##    Efisiensi_com
## 1     0.33417216
## 2     0.23949299
## 3     0.66364490
## 4     0.88667275
## 5     0.66817169
## 6    -0.31748549
## 7    -0.17236981
## 8     0.18519279
## 9     0.52282218
## 10    0.08846877
## 11    0.87444475
## 12    0.34410377
## 13    0.85858458
## 14    0.81132849
## 15    0.42915188
## 16    0.87534449
## 17   -0.37624269
## 18   -0.21570795
## 19    0.29038417
## 20    0.94570884
## 21    0.38138237
## 22   -0.48032486
## 23   -0.23367931
## 24   -0.18010355
## 25    0.34351724
## 26    0.82751332
## 27    0.76141038
## 28   -0.36555141
## 29   -0.12308121
## 30    0.38614216
## 31    0.01055639
## 32    0.32192467
## 33   -0.06160143
## 34   -0.35220625
## 35   -0.92092590
## 36    0.11157045
## 37    0.80001126
## 38   -0.47377410

Rata-rata efisiensi:

rt_syn_2_0.4 <- mean(res_1sc_0.4$Efisiensi_syn)
rt_com_2_0.4 <- mean(res_1sc_0.4$Efisiensi_com)
rt_syn_2_0.4
## [1] 3.879988
rt_com_2_0.4
## [1] 0.228649
      h. f = 30%
res_1sc_0.3
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1607855 1458025 1539376  21047867931   25973345675    2188654678
## 2   10 2477012 2635120 2538655  19649179977   26366319829   -1538526868
## 3   11 1369103 1702713 1424619  16347459322  110933085708    9935408001
## 4   12 1635767 2024828 1694094  19996988398  151260917065   12877853439
## 5   13 1642527 1425976 1588579  13430816149   50050160312    7913526173
## 6   14 2623778 2596654 2599650  26346672526    -574289345   -8437920371
## 7   15 5098079 4844026 4880009 186569027264  -20596803312  -48804349033
## 8   16 2725487 2576611 2662480  18081815026   22996337056     321293354
## 9   17 2030838 2259080 2087056  18325335545   53438474147    3192752873
## 10  18 1825502 1695525 1769160  13116683423   16559069192    2043712748
## 11  19 1819960 2232123 1866023  15377931362  172944922400   11999967010
## 12   2 1590499 1446695 1523021  18439144198   20126158879    2556919872
## 13  20 1893050 1506406 1827205  24442030583  148030772219   18961866284
## 14  21 1533499 1835180 1594194  15976789445   92093181287    9191409725
## 15  22 2017257 1841597 1945767  19613808658   27784505826    4862206136
## 16  23 2108991 2540435 2174742  24218577372  191119976989   16016010624
## 17  24 2676310 2700212 2683874  23421977845   11584679498   -4955902420
## 18  25 3916200 3708754 3774878 137058968422   17710412060  -24397473366
## 19  26 1987171 2200790 2061561  26939252828   42339730257    2374973701
## 20  27 1783670 1327166 1742773  18137083065  204013824526   16232942681
## 21  28 1592698 1841508 1675165  25350413476   57735318081    4915001006
## 22  29 1912693 1991006 1955150  31825897313  -13135577273  -19411606997
## 23   3 1739438 1859849 1767378  30599903497   15055071228  -10239258759
## 24   4 2307529 2416594 2345498  30584240182   14379795214   -7184567629
## 25   5 2060692 1870152 1986451  21059443056   39022227213    6695020446
## 26   6 2456396 2094479 2364569  35988855623  130508710007   21333271938
## 27   7 2689763 3060472 2763150  23314744912  131796860398   14589666580
## 28  71 2306957 2270559 2270171  45369508545   -9791083869  -18682321538
## 29  72 1865543 2033541 1915527  47274809907   25134386783  -15277522247
## 30  73 3373017 3043822 3218444  89248650788   95514420483   11777006058
## 31  74 2105539 2041372 2079400  15586025434    7600874114   -2219827312
## 32  75 1780481 2115122 1829249  33369440130  127560764191   -2976050534
## 33  76 2031371 1951186 1979572  28844716989    6402514698   -5811653289
## 34  77 2195552 2179510 2175145  62616938813  -12048721068  -25949328039
## 35  78 6913568 6867905 6867905 388979749951 -368325184185 -368325184185
## 36  79 2125819 1966713 2058819  19296351628   26337558305    3081195959
## 37   8 2046008 1735026 1981884  19253686511   96226594011   13882838674
## 38   9 2249658 2218546 2215371  29539666318   -4916729694  -10206875403
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1        12748.928      19200.6655      1113.58865    1.23401314
## 2         7878.478       9948.6763      -413.13075    1.34185344
## 3        11652.186      65112.3886      7123.54239    6.78595270
## 4        12075.937      74419.9513      7873.95031    7.56418487
## 5         7975.010      36242.6358      4781.46043    3.72651667
## 6         9991.638       -256.1911     -3281.67607   -0.02179741
## 7        35591.156      -4047.0458    -10103.22443   -0.11039776
## 8         6629.496       8969.4465       -35.62104    1.27179362
## 9         8882.412      23607.8394      1833.77725    2.91609799
## 10        7135.297       9852.0985       976.16486    1.26244331
## 11        8329.698      77322.2482      6464.43770   11.24630604
## 12       11389.531      13918.3561      1289.71265    1.09149094
## 13       12765.569      98972.8088     10085.24152    6.05640238
## 14       10303.924      49844.9320      5984.30777    5.76418570
## 15        9560.089      15206.5414      2212.27758    1.41657881
## 16       11391.903      74999.3914      7596.80010    7.89146175
## 17        8688.028       4037.0240     -1867.04925    0.49460723
## 18       33825.105       4690.9490     -7156.65058    0.12921746
## 19       13429.810      18740.4994      1438.17142    1.57167426
## 20       10035.750     156321.9819      9187.26211   11.24843636
## 21       15704.314      31357.3494      3534.32256    2.27749019
## 22       15892.121      -6334.1987     -9281.10119   -0.41273235
## 23       17011.765       8153.5197     -5114.81032    0.49199734
## 24       13069.262       5826.8869     -2838.85134    0.47017010
## 25       10035.487      20955.8968      3011.12684    1.85295628
## 26       14331.858      63093.3588      8537.29858    3.62636454
## 27        8605.292      42639.7428      5346.18341    5.65294027
## 28       19061.871      -4250.7579     -8255.79736   -0.21580758
## 29       24474.331      12303.0031     -7023.92479    0.53166553
## 30       26149.935      31796.9571      2698.69515    1.07020576
## 31        7359.949       3768.6368     -1177.83190    0.48767238
## 32       17592.210      60265.9439      -100.36615    3.82268218
## 33       13999.710       3316.0933     -3138.39655    0.22196490
## 34       27757.137      -5538.6085    -12023.14644   -0.19241952
## 35       54384.901     -52018.3599    -52018.35991   -0.94690067
## 36        8943.225      13678.2748      1251.72741    1.36489834
## 37        9289.657      56162.8948      6799.57389    4.99782699
## 38       12600.152      -2130.3269     -4549.37525   -0.16644500
##    Efisiensi_com
## 1     0.10398463
## 2    -0.07829980
## 3     0.60776466
## 4     0.64398964
## 5     0.58920665
## 6    -0.32026513
## 7    -0.26158870
## 8     0.01776887
## 9     0.17422616
## 10    0.15581018
## 11    0.78033688
## 12    0.13866803
## 13    0.77578932
## 14    0.57529767
## 15    0.24789709
## 16    0.66131096
## 17   -0.21159197
## 18   -0.17800713
## 19    0.08816034
## 20    0.89501397
## 21    0.19388248
## 22   -0.60993118
## 23   -0.33461735
## 24   -0.23491078
## 25    0.31791061
## 26    0.59277439
## 27    0.62576994
## 28   -0.41178144
## 29   -0.32316412
## 30    0.13195724
## 31   -0.14242421
## 32   -0.08918491
## 33   -0.20148068
## 34   -0.41441387
## 35   -0.94690067
## 36    0.15967764
## 37    0.72104834
## 38   -0.34553117

Rata-rata efisiensi:

rt_syn_2_0.3 <- mean(res_1sc_0.3$Efisiensi_syn)
rt_com_2_0.3 <- mean(res_1sc_0.3$Efisiensi_com)
rt_syn_2_0.3
## [1] 2.574093
rt_com_2_0.3
## [1] 0.1077409
      i. f = 20%
res_1sc_0.2
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1565874 1429587 1497696  34942720405   28223500994    -326202804
## 2   10 2439231 2629295 2491992  31280515784   42659833896   -3099692305
## 3   11 1431553 1696380 1503065  31997654158   68288902543   -1685893090
## 4   12 1639969 2024446 1723023  33406100117  149935161157   11412381680
## 5   13 1566874 1397051 1501298  19378905470   31700846505    5055961530
## 6   14 2649779 2550409 2592252  44606400762    7546909639   -9505757612
## 7   15 5049695 4756906 4823993 303974422936  -23740048821  -75999400065
## 8   16 2692722 2531982 2630111  31162768133   31090916146   -2939991483
## 9   17 1976454 2241914 2057330  32442570119   67250303618    -907220444
## 10  18 1809757 1695991 1753076  21536088203   13323630931   -1414673300
## 11  19 1843529 2219376 1915702  26136324172  144042388219   12202736413
## 12   2 1619071 1457465 1530261  32770568474   17554497106   -1725057448
## 13  20 1878370 1503566 1775025  43155234850  139386782607   23589651178
## 14  21 1547200 1853100 1626731  29339817179   94537884266    6875664659
## 15  22 1982165 1827205 1910060  30981843185   26168496707    2591284253
## 16  23 2046435 2495356 2130948  39060304456  208902032904   17570340304
## 17  24 2598284 2569299 2577614  37798320676   17732306821   -4700964106
## 18  25 3667898 3587087 3558572 220334116336  -57892444147  -86141255051
## 19  26 2025389 2219617 2101317  48960322037   25036123861  -13443859879
## 20  27 1804441 1321820 1743413  28362536498  228427754083   23711457768
## 21  28 1584560 1840268 1675220  41144566165   56316869146   -3467960409
## 22  29 1867452 1966266 1928930  58464192785  -31123887080  -41097412521
## 23   3 1793928 1865073 1806235  57952172782   -3687153335  -25373483809
## 24   4 2310403 2411836 2345888  53429744704    1721210661  -22890232019
## 25   5 1993151 1883273 1911861  37046441334   11107083224   -6192671460
## 26   6 2510580 2130768 2383723  60400515984  145941236666   29375673264
## 27   7 2647037 2983702 2735354  36451353014  109155662534    9563279120
## 28  71 2292464 2236598 2231043  73017566239  -12411756024  -33131788509
## 29  72 1765647 2012866 1825386  72081341140   64543591160  -25660266927
## 30  73 3455003 3034669 3235743 162421731143  162376208009   22040929052
## 31  74 2154906 2017647 2101349  27989660933   29042779887    -793485783
## 32  75 1783231 2086096 1847761  59290208293   95854809024  -20965847301
## 33  76 1956851 1930207 1938058  46991219199   -7967482422  -21667707596
## 34  77 2128534 2158084 2109221  91024870062    1557861299  -33487239094
## 35  78 6976462 6951251 6951251 773025841305 -733983861286 -733983861286
## 36  79 2095567 1944226 2015935  33770266000   14742754038   -4223082409
## 37   8 2006574 1709529 1918487  29728581101  100720175269   14535562786
## 38   9 2258432 2245263 2221725  52934909164  -14124253403  -23666301836
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         21171.41      21204.1922       -956.1336    0.80770760
## 2         12663.61      15941.7393       -849.1298    1.36378294
## 3         21523.36      39929.0040        166.6209    2.13418466
## 4         19858.07      73665.6914       7523.6936    4.48825695
## 5         11917.46      24072.7962       3021.1006    1.63584298
## 6         16724.43       2956.0306      -3920.2732    0.16918894
## 7         57624.76      -5432.8275     -16754.4596   -0.07809884
## 8         11567.65      12403.3981      -1460.1000    0.99769430
## 9         15938.50      29991.5298        235.0442    2.07290308
## 10        11819.04       7999.8530      -1119.4907    0.61866532
## 11        13934.35      64871.1525       6810.6335    5.51119535
## 12        19805.90      12837.3053      -1638.3620    0.53567875
## 13        22512.88      93608.9556      12187.2477    3.22989281
## 14        18534.27      50457.1817       4990.8741    3.22217019
## 15        15249.25      14749.0940        935.3273    0.84463976
## 16        18854.97      83447.0307       9051.9313    5.34819264
## 17        14333.81       7326.6153      -1779.0608    0.46912949
## 18        57199.67     -15562.6678     -23638.8208   -0.26274843
## 19        23487.32      11354.5875      -5459.0926    0.51135538
## 20        15294.66     177317.1391      13238.2824    8.05385492
## 21        25296.68      30608.7471       -532.6829    1.36875594
## 22        29088.54     -14037.1706     -19205.0486   -0.53235811
## 23        31118.87      -2029.4059     -13323.2167   -0.06362407
## 24        22504.13        778.6575      -9259.8011    0.03221447
## 25        18091.91       5958.6704      -3598.7524    0.29981512
## 26        22940.14      68843.5487      11165.6115    2.41622500
## 27        13520.02      35913.2637       3851.0862    2.99455723
## 28        30560.55      -5551.1852     -14939.5117   -0.16998315
## 29        38089.73      32530.2210     -11306.4500    0.89542717
## 30        45962.79      52157.1687       4319.5653    0.99971972
## 31        12916.75      14858.0884       -669.4142    1.03762528
## 32        30520.56      45579.7876      -8532.9819    1.61670555
## 33        23802.69      -4222.1175     -11384.7178   -0.16955258
## 34        40542.41        702.1174     -15278.8857    0.01711468
## 35       105975.37    -101639.8617    -101639.8617   -0.94949460
## 36        15824.89       7775.7518      -2547.4317    0.43656020
## 37        14464.52      60383.9746       6920.4259    3.38799134
## 38        22021.77      -5870.3865     -10143.2506   -0.26682304
##    Efisiensi_com
## 1   -0.009335358
## 2   -0.099093389
## 3   -0.052688021
## 4    0.341625680
## 5    0.260900263
## 6   -0.213102995
## 7   -0.250019062
## 8   -0.094343079
## 9   -0.027963889
## 10  -0.065688499
## 11   0.466888011
## 12  -0.052640449
## 13   0.546623168
## 14   0.234345859
## 15   0.083638802
## 16   0.449825995
## 17  -0.124369655
## 18  -0.390957408
## 19  -0.274586835
## 20   0.836013301
## 21  -0.084287203
## 22  -0.702950140
## 23  -0.437834901
## 24  -0.428417395
## 25  -0.167159685
## 26   0.486348052
## 27   0.262357315
## 28  -0.453750929
## 29  -0.355990420
## 30   0.135701848
## 31  -0.028349246
## 32  -0.353613993
## 33  -0.461101201
## 34  -0.367891095
## 35  -0.949494599
## 36  -0.125053276
## 37   0.488942366
## 38  -0.447083073

Rata-rata efisiensi:

rt_syn_2_0.2 <- mean(res_1sc_0.2$Efisiensi_syn)
rt_com_2_0.2 <- mean(res_1sc_0.2$Efisiensi_com)
rt_syn_2_0.2
## [1] 1.44801
rt_com_2_0.2
## [1] -0.06380408
      j. f = 10%
res_1sc_0.1
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1474412 1370798 1398517 8.362945e+10  1.573635e+10 -1.670109e+10
## 2   10 2466415 2566205 2500242 7.489146e+10 -6.572291e+09 -3.495379e+10
## 3   11 1350222 1629922 1435806 6.121087e+10  6.877142e+10 -1.050072e+10
## 4   12 1616836 1943930 1706649 7.068443e+10  1.071151e+11 -1.078058e+10
## 5   13 1600199 1341919 1509242 4.784029e+10  9.105960e+10  1.361434e+10
## 6   14 2508111 2504699 2483883 9.621367e+10 -9.409786e+09 -4.225002e+10
## 7   15 5044368 4718471 4758172 7.622693e+11 -3.390843e+11 -3.987273e+11
## 8   16 2715099 2485802 2627401 6.977470e+10  8.029343e+10 -1.035831e+09
## 9   17 1988602 2188734 2031881 6.920891e+10  3.070073e+10 -3.414677e+10
## 10  18 1803904 1634797 1712497 5.054491e+10  3.479456e+10 -3.312870e+09
## 11  19 1740350 2154349 1846664 5.875218e+10  1.689359e+11  1.929112e+09
## 12   2 1492548 1393112 1426764 6.460725e+10  2.143270e+10 -1.201293e+10
## 13  20 1864903 1435537 1695902 9.058667e+10  1.619649e+11  3.750861e+10
## 14  21 1547052 1778241 1611858 6.331594e+10  6.232095e+10 -1.199937e+10
## 15  22 1822352 1783252 1782687 5.326715e+10  9.026443e+09 -1.426812e+10
## 16  23 2016878 2448800 2150192 8.742033e+10  1.781930e+11 -2.131493e+09
## 17  24 2550396 2573544 2528963 8.595585e+10  1.967676e+10 -2.791247e+10
## 18  25 3732677 3568919 3550710 5.009683e+11 -1.554958e+11 -1.973917e+11
## 19  26 1864495 2133159 1953908 9.994400e+10  6.701125e+10 -2.558275e+10
## 20  27 1736203 1243860 1611531 6.296103e+10  2.189475e+11  3.706146e+10
## 21  28 1476617 1755054 1568783 8.930235e+10  6.578631e+10 -2.727854e+10
## 22  29 1838937 1885023 1854455 1.155261e+11 -7.180313e+10 -8.368762e+10
## 23   3 1649226 1786829 1667953 1.085560e+11  1.576314e+10 -4.615581e+10
## 24   4 2320461 2344984 2281191 1.255233e+11 -1.670971e+10 -6.169769e+10
## 25   5 2029842 1808988 1898281 9.071582e+10  5.944582e+10 -2.938630e+09
## 26   6 2418303 2052249 2245938 1.281240e+11  1.171156e+11  2.123465e+10
## 27   7 2502185 2960117 2640620 8.123614e+10  1.779783e+11  9.990031e+09
## 28  71 2276058 2163693 2156850 1.734592e+11 -7.722426e+07 -3.978049e+10
## 29  72 1486706 1933537 1557768 1.121681e+11  1.863377e+11 -4.768131e+10
## 30  73 3195014 2946242 2993060 3.336357e+11 -1.625237e+10 -9.364797e+10
## 31  74 1947222 1939601 1932614 5.348505e+10 -3.245597e+09 -1.974512e+10
## 32  75 1875994 2011022 1895078 1.473517e+11 -7.144589e+09 -6.662035e+10
## 33  76 1734900 1851219 1756841 8.519009e+10  1.972878e+10 -2.871763e+10
## 34  77 2152122 2078441 2041696 2.169290e+11 -2.112450e+10 -8.203359e+10
## 35  78 6842669 6805761 6805761 1.330918e+12 -1.270101e+12 -1.270101e+12
## 36  79 2085723 1866890 1974060 7.450703e+10  4.683627e+10  4.928884e+08
## 37   8 2011617 1652253 1877265 7.095530e+10  1.229781e+11  2.160185e+10
## 38   9 2141691 2181358 2139348 7.494735e+10 -2.127108e+10 -3.908086e+10
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         50980.13      14444.4356      -13349.266  0.1881675414
## 2         29624.74      -2650.9840      -13268.662 -0.0877575472
## 3         41908.25      42802.7475       -4366.685  1.1235165461
## 4         41642.07      54878.1718       -3085.366  1.5153986490
## 5         27568.79      79109.1215        7844.478  1.9034081785
## 6         37971.81      -3919.5442      -16848.349 -0.0978009263
## 7        139614.90     -67949.8391      -81630.821 -0.4448352786
## 8         25436.31      33383.1187       -1225.023  1.1507528561
## 9         32648.67      14097.6657      -14721.622  0.4435950955
## 10        27379.45      22072.2789       -2959.455  0.6883889898
## 11        32290.85      78134.1663        3026.836  2.8753988207
## 12        40601.79      17080.1740       -9277.878  0.3317383359
## 13        46449.76     114025.0407       19166.700  1.7879552257
## 14        38806.74      34449.6552       -5714.945  0.9842853590
## 15        27683.59       5983.7334       -8057.208  0.1694560959
## 16        42051.08      72202.9804        1769.543  2.0383473191
## 17        32734.03       6176.2834      -10700.351  0.2289171060
## 18       118624.64     -42810.6357      -55090.485 -0.3103905004
## 19        50825.85      30880.1290      -10508.954  0.6704879345
## 20        34407.02     185021.0635       21321.830  3.4775082546
## 21        57622.06      36053.3752      -13490.154  0.7366694650
## 22        54986.88     -32383.5116      -38227.351 -0.6215317789
## 23        59094.43       8835.0312      -24931.162  0.1452074456
## 24        51033.57      -7056.2532      -25758.368 -0.1331204057
## 25        42089.79      33329.2957       -3975.455  0.6552971572
## 26        48838.71      58388.7041        7122.037  0.9140797627
## 27        31376.48      59737.0135        5424.670  2.1908764235
## 28        67088.48        623.1566      -18861.813 -0.0004452013
## 29        63413.38      96729.9460      -19313.799  1.6612361571
## 30        99634.47      -4679.0499      -32733.441 -0.0487129070
## 31        27437.06      -1628.7773      -10079.387 -0.0606823184
## 32        67648.57      -3353.4921      -31926.068 -0.0484866418
## 33        46036.31      10402.5675      -14834.230  0.2315854431
## 34        89857.63      -8677.8664      -39163.772 -0.0973797759
## 35       181235.66    -175015.7063     -175015.706 -0.9543044564
## 36        33692.69      25260.0453       -1316.589  0.6286155483
## 37        33578.41      77122.8655        9651.747  1.7331766214
## 38        31802.75      -8939.5920      -16618.371 -0.2838136786
##    Efisiensi_com
## 1   -0.199703474
## 2   -0.466725975
## 3   -0.171549930
## 4   -0.152517063
## 5    0.284578885
## 6   -0.439127042
## 7   -0.523079341
## 8   -0.014845364
## 9   -0.493386949
## 10  -0.065543102
## 11   0.032834726
## 12  -0.185937785
## 13   0.414063248
## 14  -0.189515777
## 15  -0.267859672
## 16  -0.024382123
## 17  -0.324730305
## 18  -0.394020289
## 19  -0.255970878
## 20   0.588641268
## 21  -0.305462695
## 22  -0.724404555
## 23  -0.425179694
## 24  -0.491523961
## 25  -0.032393797
## 26   0.165735075
## 27   0.122975210
## 28  -0.229336335
## 29  -0.425087829
## 30  -0.280689293
## 31  -0.369170729
## 32  -0.452117986
## 33  -0.337100586
## 34  -0.378158735
## 35  -0.954304456
## 36   0.006615328
## 37   0.304443013
## 38  -0.521444219

Rata-rata efisiensi:

rt_syn_2_0.1 <- mean(res_1sc_0.1$Efisiensi_syn)
rt_com_2_0.1 <- mean(res_1sc_0.1$Efisiensi_com)
rt_syn_2_0.1
## [1] 0.6653896
rt_com_2_0.1
## [1] -0.2151417
      k. f = 5%
res_1sc_0.05
##    kab   Y dir   Y syn   Y com      MSE dir       MSE syn       MSE com
## 1    1 1485403 1304574 1349337 1.811192e+11  4.524334e+10 -4.023127e+10
## 2   10 2442296 2481150 2438467 1.515579e+11  3.705079e+10 -5.225508e+10
## 3   11 1208853 1502209 1243986 1.221906e+11  1.089398e+11 -4.299427e+10
## 4   12 1680146 1740627 1630024 1.729213e+11  1.657019e+10 -8.926775e+10
## 5   13 1533738 1279680 1423013 7.573877e+10  1.116688e+11  1.378217e+08
## 6   14 2284936 2476581 2324186 1.847637e+11  5.063780e+10 -7.255880e+10
## 7   15 5178744 4622091 4677051 1.498139e+12 -4.671302e+11 -6.470369e+11
## 8   16 2696329 2436228 2557769 1.570469e+11  3.267256e+10 -4.108699e+10
## 9   17 1978475 2118127 1962101 1.508735e+11  2.085489e+10 -6.414150e+10
## 10  18 1868387 1551065 1729205 1.172519e+11  9.873737e+10  8.988747e+09
## 11  19 1469693 2019440 1571355 1.045470e+11  2.961264e+11 -3.156222e+10
## 12   2 1302446 1303857 1274648 1.119387e+11  3.792408e+09 -4.504372e+10
## 13  20 1601115 1315922 1415459 1.640984e+11  9.752889e+10 -2.023166e+10
## 14  21 1490601 1618456 1480213 1.199529e+11  3.852777e+10 -3.558387e+10
## 15  22 1819501 1752638 1746740 1.162658e+11 -1.630609e+10 -4.345809e+10
## 16  23 2066684 2393656 2146122 1.686773e+11  1.000401e+11 -7.340958e+10
## 17  24 2649619 2708026 2624915 2.278901e+11 -3.135256e+10 -1.223350e+11
## 18  25 3613853 3578190 3511134 7.438193e+11 -2.637757e+11 -4.057324e+11
## 19  26 1558812 1853655 1608182 1.781009e+11  6.179141e+10 -1.055248e+11
## 20  27 1428695 1030543 1281622 8.997022e+10  1.203525e+11  6.591272e+09
## 21  28 1259832 1527781 1326691 1.375232e+11  6.570052e+10 -7.073626e+10
## 22  29 1876570 1793521 1802071 2.011090e+11 -1.273304e+11 -1.443929e+11
## 23   3 1454547 1610971 1446624 2.355839e+11 -1.798605e+10 -1.170369e+11
## 24   4 2259415 2208072 2180339 2.332514e+11 -3.243069e+09 -7.395320e+10
## 25   5 1982878 1665994 1788116 1.822995e+11  3.722882e+10 -2.771770e+10
## 26   6 2099242 1902682 1947315 2.466143e+11  1.259596e+09 -5.335730e+10
## 27   7 2492877 3062151 2640420 1.729104e+11  2.831316e+11 -2.897613e+10
## 28  71 2394477 1979750 2122094 4.318978e+11 -3.876749e+10 -1.313264e+11
## 29  72 1575159 1724349 1506340 3.302861e+11 -3.311593e+09 -1.677982e+11
## 30  73 2767888 2721627 2616219 6.188210e+11 -1.514434e+11 -3.187193e+11
## 31  74 1530206 1741402 1578449 8.983359e+10  4.013511e+10 -5.078979e+10
## 32  75 1476924 1820247 1525358 1.478340e+11  1.360839e+11 -7.837404e+10
## 33  76 1679902 1647915 1609684 1.493627e+11  1.334886e+10 -6.349604e+10
## 34  77 1794893 1869024 1757003 3.493149e+11  6.954866e+10 -1.713653e+11
## 35  78 6238848 6238045 6228667 2.833200e+12 -2.704769e+12 -2.708750e+12
## 36  79 1648235 1674959 1615465 1.182821e+11 -8.263356e+09 -6.806841e+10
## 37   8 2016827 1598346 1817114 1.533652e+11  1.524074e+11  1.762551e+10
## 38   9 2087040 2120534 2026980 2.532612e+11 -5.863253e+10 -1.247400e+11
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         95063.73       96463.174     -31348.0789   0.249798633
## 2         58396.50       14491.563     -21450.9798   0.244466200
## 3         80873.08       73066.002     -24563.9772   0.891556265
## 4         92853.66        8096.865     -51609.5395   0.095825051
## 5         44626.29      108680.335       -207.2849   1.474393649
## 6         77644.69       19924.446     -28559.7661   0.274067954
## 7        245667.61      -91999.772    -131393.4276  -0.311807081
## 8         57181.21       13892.216     -18197.8174   0.208043302
## 9         66206.35        9868.017     -28893.5710   0.138227660
## 10        59148.03       66791.762       1020.5561   0.842095907
## 11        63588.99      144049.946     -11283.0937   2.832472426
## 12        76877.36        4781.900     -33533.8528   0.033879331
## 13        88368.32       73114.947     -19777.4644   0.594331760
## 14        70806.04       22282.518     -20748.9865   0.321190793
## 15        56908.38       -8580.767     -23777.5055  -0.140248432
## 16        76308.53       41193.751     -27745.1095   0.593085708
## 17        80051.34      -10529.192     -43458.2748  -0.137577530
## 18       178002.47      -77334.295    -113362.3186  -0.354623374
## 19        98611.26       27062.039     -53108.2728   0.346946103
## 20        55742.33      146969.766       2885.3596   1.337693111
## 21        96247.41       38588.002     -45010.3330   0.477741399
## 22        86549.76      -51336.933     -63213.8135  -0.633141266
## 23       127609.90      -10061.516     -69904.6794  -0.076346707
## 24        91881.27       -1926.121     -34909.7449  -0.013903746
## 25        82899.26       24939.698     -19486.9529   0.204217841
## 26        97468.79        3344.768     -28202.5576   0.005107554
## 27        63206.31       91365.106      -3705.6176   1.637446831
## 28       157588.40      -15339.369     -69473.6085  -0.089760814
## 29       149935.84        3366.168     -88631.2826  -0.010026438
## 30       198554.92      -53301.572    -113455.6289  -0.244728863
## 31        57115.04       20897.013     -28650.9450   0.446771793
## 32        83958.77       73970.776     -40056.0092   0.920518474
## 33        77947.82        7922.049     -38144.1216   0.089372097
## 34       156870.54       35650.235     -89615.9439   0.199100204
## 35       376731.62     -364139.542    -365008.2404  -0.954669143
## 36        60558.81       -4266.518     -38829.9504  -0.069861397
## 37        70489.54      105898.878       5392.8459   0.993754665
## 38        97029.52      -26582.184     -54852.1020  -0.231510142
##    Efisiensi_com
## 1   -0.222125869
## 2   -0.344786234
## 3   -0.351862291
## 4   -0.516233519
## 5    0.001819698
## 6   -0.392711397
## 7   -0.431893899
## 8   -0.261622363
## 9   -0.425134398
## 10   0.076661825
## 11  -0.301895126
## 12  -0.402396359
## 13  -0.123289793
## 14  -0.296648673
## 15  -0.373782269
## 16  -0.435207091
## 17  -0.536815591
## 18  -0.545471695
## 19  -0.592500331
## 20   0.073260592
## 21  -0.514358772
## 22  -0.717983189
## 23  -0.496795087
## 24  -0.317053537
## 25  -0.152044840
## 26  -0.216359362
## 27  -0.167578891
## 28  -0.304068298
## 29  -0.508038849
## 30  -0.515042700
## 31  -0.565376367
## 32  -0.530148888
## 33  -0.425113039
## 34  -0.490575409
## 35  -0.956074343
## 36  -0.575474946
## 37   0.114925089
## 38  -0.492535195

Rata-rata efisiensi:

rt_syn_2_0.05 <- mean(res_1sc_0.05$Efisiensi_syn)
rt_com_2_0.05 <- mean(res_1sc_0.05$Efisiensi_com)
rt_syn_2_0.05
## [1] 0.3206289
rt_com_2_0.05
## [1] -0.374535
  1. MEnggunakan rumus MSE synthetic yang perbaikan

    1. Metode SRS
      1. f = 100%
res_srs2_1
##    kab   Y dir   Y syn   Y com MSE dir     MSE syn MSE com Relatif MSE dir
## 1    1 1637409 1484546 1637409       0 53757885490       0               0
## 2   10 2452226 2656398 2452226       0 47147642278       0               0
## 3   11 1432925 1736676 1432925       0 52258061800       0               0
## 4   12 1628141 2070386 1628141       0 51433987269       0               0
## 5   13 1660654 1452773 1660654       0 50739021079       0               0
## 6   14 2677707 2617885 2677707       0 48363946648       0               0
## 7   15 5059790 4863519 5059790       0 47676545298       0               0
## 8   16 2702258 2596479 2702258       0 51495764637       0               0
## 9   17 2063216 2280593 2063216       0 50522845707       0               0
## 10  18 1802921 1720645 1802921       0 51413342911       0               0
## 11  19 1893080 2266122 1893080       0 52238481449       0               0
## 12   2 1631372 1473225 1631372       0 52199242895       0               0
## 13  20 1933963 1539654 1933963       0 52927024662       0               0
## 14  21 1543883 1871616 1543883       0 51639003528       0               0
## 15  22 2024290 1859814 2024290       0 49791054445       0               0
## 16  23 2145480 2562473 2145480       0 50544580026       0               0
## 17  24 2721467 2698896 2721467       0 50587970809       0               0
## 18  25 3923463 3722909 3923463       0 50803367638       0               0
## 19  26 2049321 2256961 2049321       0 52413770351       0               0
## 20  27 1850200 1379119 1850200       0 52179584690       0               0
## 21  28 1632444 1899669 1632444       0 52199242895       0               0
## 22  29 1945828 2049705 1945828       0 50566288393       0               0
## 23   3 1794553 1899490 1794553       0 52238481449       0               0
## 24   4 2297582 2449242 2297582       0 51351254126       0               0
## 25   5 2083579 1902456 2083579       0 50781944736       0               0
## 26   6 2526531 2124414 2526531       0 48194003740       0               0
## 27   7 2716794 3050885 2716794       0 45082946891       0               0
## 28  71 2297609 2314435 2297609       0 55404347708       0               0
## 29  72 1872873 2081921 1872873       0 56707316863       0               0
## 30  73 3484448 3097221 3484448       0 52720204779       0               0
## 31  74 2197198 2088987 2197198       0 55565778548       0               0
## 32  75 1867766 2160606 1867766       0 56429844225       0               0
## 33  76 2088732 1998934 2088732       0 56645357835       0               0
## 34  77 2275392 2228054 2275392       0 56481228047       0               0
## 35  78 7020112 6960868 7020112       0 45573428827       0               0
## 36  79 2178314 2012520 2178314       0 56206830653       0               0
## 37   8 2025630 1758243 2025630       0 51392672600       0               0
## 38   9 2279804 2230617 2279804       0 43618767484       0               0
##    Relatif MSE syn Relatif MSE com Efisiensi_syn Efisiensi_com
## 1         36211.67               0           Inf           NaN
## 2         17748.71               0           Inf           NaN
## 3         30090.85               0           Inf           NaN
## 4         24842.70               0           Inf           NaN
## 5         34925.63               0           Inf           NaN
## 6         18474.43               0           Inf           NaN
## 7          9802.89               0           Inf           NaN
## 8         19832.92               0           Inf           NaN
## 9         22153.38               0           Inf           NaN
## 10        29880.28               0           Inf           NaN
## 11        23051.93               0           Inf           NaN
## 12        35431.95               0           Inf           NaN
## 13        34375.92               0           Inf           NaN
## 14        27590.60               0           Inf           NaN
## 15        26772.07               0           Inf           NaN
## 16        19724.92               0           Inf           NaN
## 17        18743.95               0           Inf           NaN
## 18        13646.15               0           Inf           NaN
## 19        23223.17               0           Inf           NaN
## 20        37835.45               0           Inf           NaN
## 21        27478.07               0           Inf           NaN
## 22        24670.03               0           Inf           NaN
## 23        27501.31               0           Inf           NaN
## 24        20966.18               0           Inf           NaN
## 25        26692.84               0           Inf           NaN
## 26        22685.79               0           Inf           NaN
## 27        14777.01               0           Inf           NaN
## 28        23938.60               0           Inf           NaN
## 29        27237.97               0           Inf           NaN
## 30        17021.78               0           Inf           NaN
## 31        26599.39               0           Inf           NaN
## 32        26117.60               0           Inf           NaN
## 33        28337.79               0           Inf           NaN
## 34        25350.03               0           Inf           NaN
## 35         6547.09               0           Inf           NaN
## 36        27928.58               0           Inf           NaN
## 37        29229.57               0           Inf           NaN
## 38        19554.58               0           Inf           NaN

Rata-rata efisiensi:

rt_syn_3_1 <- mean(res_srs2_1$Efisiensi_syn)
rt_com_3_1 <- mean(res_srs2_1$Efisiensi_com)
rt_syn_3_1
## [1] Inf
rt_com_3_1
## [1] NaN
      b. f = 90%
res_srs2_0.9
##    kab   Y dir   Y syn   Y com    MSE dir     MSE syn    MSE com
## 1    1 1637950 1483833 1636801  402455800 54234143537  399449714
## 2   10 2450030 2654313 2452382  557099538 47713949382  550629148
## 3   11 1427539 1735603 1429626  361164162 52754751426  358678661
## 4   12 1627050 2068453 1629723  316631546 51941902978  314701658
## 5   13 1659070 1452264 1657611  361885648 51256404072  359324918
## 6   14 2676482 2616771 2675856  512694594 48913684458  507351618
## 7   15 5063089 4862328 5053225 2477638157 48235647339 2356239605
## 8   16 2700715 2595871 2699614  547294945 52002838774  541567725
## 9   17 2063877 2279751 2065627  418649197 51043173582  415216796
## 10  18 1800682 1719622 1800119  359734753 51921539850  357246890
## 11  19 1892716 2264843 1895721  429732922 52735437812  426238262
## 12   2 1629238 1472153 1628158  362173025 52696733790  359684513
## 13  20 1934881 1538533 1929191  776053326 53414601238  764893618
## 14  21 1542883 1869929 1544907  324828697 52144126371  322808186
## 15  22 2023100 1859744 2022036  329032516 50321351259  326886794
## 16  23 2144757 2561868 2148130  416394000 51064611822  413005856
## 17  24 2723196 2701128 2722851  764955135 51107411507  753531409
## 18  25 3921741 3723463 3916814 1301678096 51319874060 1269390486
## 19  26 2050800 2255073 2052031  321073774 52908338813  319130286
## 20  27 1847144 1378056 1844295  321479344 52677343383  319518253
## 21  28 1632488 1897329 1634319  366948432 52696733790  364398361
## 22  29 1942709 2045140 1943601  447958062 51086024463  444018469
## 23   3 1790989 1897676 1792192  613085059 52735437812  605943778
## 24   4 2299061 2447583 2301485  869928097 51860296879  855448952
## 25   5 2079982 1900623 2078278  488262198 51298742995  483620923
## 26   6 2527640 2121998 2521453  751388354 48746056624  739919313
## 27   7 2717801 3050413 2720953  436441679 45677380627  432291108
## 28  71 2288263 2312975 2288711 1142795661 55858176569 1119613027
## 29  72 1871201 2080292 1875094 1096658962 57143395826 1075706105
## 30  73 3481539 3093549 3470778 1513355241 53210598791 1471369701
## 31  74 2199782 2087311 2198862  458395346 56017408293  454660924
## 32  75 1867030 2159140 1870514  688724057 56869703102  680429045
## 33  76 2094468 1997346 2092675 1060924348 57082280845 1041433314
## 34  77 2270178 2226235 2269092 1384027135 56920386940 1350904141
## 35  78 7007674 6951401 7002910 4233355393 46161180897 3876715250
## 36  79 2174836 2010955 2172935  659235024 56649727567  651597946
## 37   8 2018998 1757221 2016686  459833109 51901151124  455769348
## 38   9 2277752 2228548 2277322  384197825 44233147229  380868822
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         245.4791       36551.604        243.8207     134.75801
## 2         227.3021       17975.517        224.4476      85.64708
## 3         252.7535       30396.247        250.6478     146.06862
## 4         194.5243       25111.222        193.0213     164.04526
## 5         217.9639       35295.360        216.6150     141.63702
## 6         191.5193       18692.149        189.5684      95.40511
## 7         489.2314        9919.849        466.1762      19.46840
## 8         202.6038       20032.701        200.5665      95.01794
## 9         202.7657       22389.960        200.9337     121.92350
## 10        199.7027       30194.925        198.3847     144.33284
## 11        226.9594       23284.525        224.7572     122.71677
## 12        222.1836       35798.946        220.8052     145.50154
## 13        400.8621       34719.435        396.2700      68.82852
## 14        210.4538       27886.658        208.8713     160.52808
## 15        162.6065       27060.894        161.6316     152.93732
## 16        194.0863       19932.400        192.2052     122.63532
## 17        280.7516       18921.627        276.5973      66.81099
## 18        331.8386       13782.568        324.0175      39.42593
## 19        156.5364       23462.766        155.4958     164.78561
## 20        173.9699       38229.326        173.1773     163.85919
## 21        224.6989       27774.902        222.8880     143.60801
## 22        230.4013       24982.850        228.2712     114.04198
## 23        341.9425       27789.463        337.7373      86.01651
## 24        378.1349       21188.354        371.4544      59.61446
## 25        234.6102       26990.616        232.5736     105.06393
## 26        297.1401       22972.429        293.3272      64.87465
## 27        160.5609       14973.243        158.8497     104.65861
## 28        498.9161       24149.381        488.7137      48.87853
## 29        585.4541       27468.617        573.0830      52.10681
## 30        434.5681       17200.166        423.8280      35.16068
## 31        208.3221       26836.765        206.7124     122.20327
## 32        368.7004       26338.653        363.5842      82.57255
## 33        506.2638       28578.829        497.3979      53.80429
## 34        609.2050       25567.574        594.9278      41.12664
## 35        604.0266        6640.613        553.5244      10.90416
## 36        302.9376       28170.283        299.6943      85.93252
## 37        227.6472       29536.079        225.8966     112.86954
## 38        168.6239       19848.477        167.1951     115.13118
##    Efisiensi_com
## 1      0.9925306
## 2      0.9883856
## 3      0.9931181
## 4      0.9939049
## 5      0.9929239
## 6      0.9895786
## 7      0.9510023
## 8      0.9895354
## 9      0.9918012
## 10     0.9930842
## 11     0.9918678
## 12     0.9931289
## 13     0.9856199
## 14     0.9937798
## 15     0.9934787
## 16     0.9918631
## 17     0.9850661
## 18     0.9751954
## 19     0.9939469
## 20     0.9938998
## 21     0.9930506
## 22     0.9912054
## 23     0.9883519
## 24     0.9833559
## 25     0.9904943
## 26     0.9847362
## 27     0.9904900
## 28     0.9797141
## 29     0.9808939
## 30     0.9722567
## 31     0.9918533
## 32     0.9879560
## 33     0.9816283
## 34     0.9760677
## 35     0.9157547
## 36     0.9884152
## 37     0.9911625
## 38     0.9913352

Rata-rata efisiensi:

rt_syn_3_0.9 <- mean(res_srs2_0.9$Efisiensi_syn)
rt_com_3_0.9 <- mean(res_srs2_0.9$Efisiensi_com)
rt_syn_3_0.9
## [1] 99.86583
rt_com_3_0.9
## [1] 0.9855904
      c. f = 80%
res_srs2_0.8
##    kab   Y dir   Y syn   Y com    MSE dir     MSE syn    MSE com
## 1    1 1639780 1483803 1637150  919625802 54730698482  904030309
## 2   10 2447781 2654147 2452924 1243869640 48336975012 1212224058
## 3   11 1433045 1734770 1437612  824183467 53280001795  811344345
## 4   12 1630086 2069539 1635924  708581283 52482919978  698955532
## 5   13 1661093 1452800 1657792  820771653 51810717535  807691097
## 6   14 2674741 2616757 2673397 1122671712 49513439107 1097316928
## 7   15 5060801 4864062 5040501 5545086783 48848553716 4975831995
## 8   16 2689936 2594761 2687762 1198420257 52542673817 1171331300
## 9   17 2064539 2277695 2068352  946993461 51601623027  929726820
## 10  18 1797108 1717211 1795877  797287196 52462951830  785215189
## 11  19 1887099 2263562 1893598  939015769 53261062802  922487338
## 12   2 1624684 1469152 1622308  815433485 53223109514  802987571
## 13  20 1923422 1537323 1911560 1691978325 53927052654 1639697812
## 14  21 1541665 1867975 1546025  715239562 52681220892  705493873
## 15  22 2017671 1855103 2015335  735005217 50893801724  724447395
## 16  23 2155830 2560944 2163128  948375390 51622645434  931091455
## 17  24 2724848 2699051 2723931 1760386684 51664614944 1701367906
## 18  25 3922965 3724353 3912300 2920020355 51872956410 2763532291
## 19  26 2048536 2255033 2051276  719886064 53430610083  710244904
## 20  27 1847701 1379940 1841499  711359832 53204095217  701781462
## 21  28 1634144 1899721 1638207  828221618 53223109514  815395899
## 22  29 1945016 2050055 1947048 1023140588 51643642740 1002812305
## 23   3 1793947 1897861 1796516 1395390064 53261062802 1358843217
## 24   4 2295009 2446453 2300178 1916328728 52402896774 1846770386
## 25   5 2081892 1900055 2077984 1122636524 51852235220 1098578301
## 26   6 2528004 2119956 2514165 1713315458 49349062711 1655038009
## 27   7 2716072 3051718 2723028  977407849 46339909106  957058965
## 28  71 2295165 2315165 2295807 2615668686 56323230525 2496901977
## 29  72 1869626 2082161 1877957 2414130748 57583520683 2312792840
## 30  73 3490320 3096499 3466279 3471167619 53727007195 3259330280
## 31  74 2197964 2089424 2195985 1035289894 56479373668 1016524850
## 32  75 1869696 2161092 1877430 1572726951 57315136713 1530301522
## 33  76 2090132 1999232 2086347 2378655121 57523591135 2282357437
## 34  77 2275681 2228257 2272931 3091588288 57364837448 2930016337
## 35  78 7013607 6956193 7003756 9577135301 46814325215 7943236739
## 36  79 2177799 2012784 2173569 1484193904 57099427992 1446235069
## 37   8 2025710 1757294 2020356 1059226537 52442958579 1038058946
## 38   9 2275558 2226769 2274627  851434210 44923689166  835375354
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         559.8589       36892.594        551.2873     59.514096
## 2         507.8006       18211.976        493.8550     38.860161
## 3         574.1203       30715.036        563.3818     64.645803
## 4         434.0884       25359.755        426.6611     74.067607
## 5         493.3348       35668.686        486.4728     63.124399
## 6         419.4313       18921.566        410.1793     44.103221
## 7        1095.2072       10041.938        986.8075      8.809340
## 8         445.2618       20249.381        435.5623     43.843279
## 9         458.2678       22655.851        449.0922     54.489947
## 10        443.2183       30555.084        436.8209     65.801824
## 11        497.1211       23529.927        486.6948     56.720094
## 12        501.3925       36235.097        494.4799     65.269713
## 13        877.6568       35083.286        855.9633     31.872189
## 14        463.3682       28204.519        455.7685     73.655351
## 15        364.0767       27439.350        359.2697     69.242776
## 16        439.6350       20157.499        430.1706     54.432713
## 17        645.3347       19143.713        623.9415     29.348447
## 18        743.9634       13927.341        706.0397     17.764587
## 19        351.2494       23694.182        346.0848     74.220926
## 20        384.4822       38561.767        380.6117     74.792099
## 21        506.4785       28016.977        497.4039     64.261918
## 22        525.1596       25197.916        514.2006     50.475608
## 23        776.5188       28064.902        755.1387     38.169301
## 24        833.4142       21419.884        801.4253     27.345463
## 25        538.7771       27291.655        528.2453     46.187910
## 26        677.1027       23280.777        657.7299     28.803255
## 27        359.7469       15184.937        351.3585     47.411026
## 28       1137.2634       24327.769       1085.4851     21.533014
## 29       1287.2248       27656.088       1227.7710     23.852693
## 30        993.9386       17350.151        939.8148     15.478079
## 31        470.8496       27031.415        462.7385     54.554163
## 32        840.4495       26521.629        814.4360     36.443158
## 33       1135.8768       28773.709       1092.0267     24.183241
## 34       1354.8918       25744.241       1285.9395     18.555135
## 35       1364.9743        6729.804       1133.7783      4.888134
## 36        680.9547       28369.234        664.8610     38.471677
## 37        522.4494       29845.973        513.3857     49.510616
## 38        373.9557       20177.150        367.0601     52.762373
##    Efisiensi_com
## 1      0.9830415
## 2      0.9745588
## 3      0.9844220
## 4      0.9864155
## 5      0.9840631
## 6      0.9774157
## 7      0.8973407
## 8      0.9773961
## 9      0.9817669
## 10     0.9848586
## 11     0.9823981
## 12     0.9847371
## 13     0.9691010
## 14     0.9863742
## 15     0.9856357
## 16     0.9817752
## 17     0.9664740
## 18     0.9464086
## 19     0.9866074
## 20     0.9865351
## 21     0.9845141
## 22     0.9801315
## 23     0.9738089
## 24     0.9637023
## 25     0.9785699
## 26     0.9659856
## 27     0.9791808
## 28     0.9545941
## 29     0.9580230
## 30     0.9389723
## 31     0.9818746
## 32     0.9730243
## 33     0.9595159
## 34     0.9477382
## 35     0.8293959
## 36     0.9744246
## 37     0.9800160
## 38     0.9811391

Rata-rata efisiensi:

rt_syn_3_0.8 <- mean(res_srs2_0.8$Efisiensi_syn)
rt_com_3_0.8 <- mean(res_srs2_0.8$Efisiensi_com)
rt_syn_3_0.8
## [1] 44.9333
rt_com_3_0.8
## [1] 0.9687352
      d. f = 70%
res_srs2_0.7
##    kab   Y dir   Y syn   Y com     MSE dir     MSE syn     MSE com
## 1    1 1639426 1483879 1635086  1559774074 56196607806  1515532270
## 2   10 2447562 2654970 2455963  2121674978 49860841030  2032977372
## 3   11 1431042 1735672 1438724  1425652326 54759061138  1388353298
## 4   12 1625684 2067821 1635308  1206640896 53969204568  1179449573
## 5   13 1662990 1453841 1657326  1448664815 53303095386  1409054181
## 6   14 2680686 2617089 2678224  1970642517 51026640922  1895488970
## 7   15 5061846 4859941 5028879  9555627259 50367782466  8008043626
## 8   16 2698522 2595133 2694495  2096850852 54028416760  2016798171
## 9   17 2056607 2279864 2063061  1605599869 53095896242  1557333689
## 10  18 1802901 1719927 1800711  1403292030 53949417423  1367038245
## 11  19 1894920 2263677 1905788  1673794401 54740293821  1622598989
## 12   2 1629906 1472490 1625854  1409967899 54702684564  1373794237
## 13  20 1929668 1538315 1909502  2967285094 55400246725  2813141743
## 14  21 1543480 1869632 1550776  1246082453 54165707958  1217362205
## 15  22 2028002 1860017 2023891  1292146659 52394491071  1260593393
## 16  23 2141020 2561266 2153451  1617215647 53116728089  1568504586
## 17  24 2724640 2700996 2723135  3037863835 53158317160  2866770897
## 18  25 3916633 3721676 3899747  4967565878 53364770089  4539912820
## 19  26 2048962 2254388 2053495  1242697963 54908304219  1214833884
## 20  27 1846824 1379007 1836614  1210827542 54683842625  1183785637
## 21  28 1631258 1897240 1637960  1418416779 54702684564  1381858740
## 22  29 1941901 2045450 1945084  1710370698 53137535061  1655023706
## 23   3 1792194 1897280 1796316  2372906958 54740293821  2270210841
## 24   4 2293040 2446923 2301423  3280618704 53889906744  3083731482
## 25   5 2083704 1901181 2077371  1866861662 53344236729  1802067360
## 26   6 2528186 2122537 2505649  2940510400 50863754536  2776869731
## 27   7 2720633 3052788 2732007  1682525230 47881877774  1624453952
## 28  71 2300438 2311118 2300558  4472031300 57774704146  4138986004
## 29  72 1871024 2078374 1884148  4247972892 59023570249  3944188570
## 30  73 3480240 3091258 3442228  5919522541 55202014603  5341347529
## 31  74 2203982 2085563 2200431  1746819520 57929431911  1695002157
## 32  75 1857672 2157231 1870401  2637899531 58757619079  2522134832
## 33  76 2092686 1995526 2085821  4137882775 58964183940  3858995480
## 34  77 2257345 2224207 2253802  5168087718 58806869296  4733452398
## 35  78 7004214 6946581 6989361 16260783068 48351993480 12135487476
## 36  79 2171649 2009237 2164751  2514593575 58543865676  2408990385
## 37   8 2020381 1757836 2011818  1778010383 53929605404  1719896646
## 38   9 2279357 2231296 2277764  1487553668 46478495335  1440026753
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         948.4946       37875.115        924.2400     36.028684
## 2         865.8880       18779.852        826.9034     23.500697
## 3         994.2230       31550.601        963.0596     38.409828
## 4         740.5269       26099.945        719.5779     44.726815
## 5         868.8646       36675.935        848.1433     36.794637
## 6         734.5414       19497.066        707.2213     25.893403
## 7        1885.9028       10364.638       1591.2436      5.271007
## 8         775.9973       20818.600        747.5643     25.766457
## 9         779.3149       23289.384        753.5709     33.069196
## 10        776.9804       31367.441        757.8889     38.444897
## 11        881.4544       24180.966        849.6448     32.704312
## 12        863.4789       37151.495        843.5099     38.797113
## 13       1533.3437       36013.937       1469.5730     18.670348
## 14        805.5762       28971.421        783.3309     43.468799
## 15        636.5243       28173.540        622.2721     40.548409
## 16        754.6409       20738.307        727.6988     32.844555
## 17       1112.4244       19686.982       1050.5560     17.498585
## 18       1267.3165       14340.119       1163.3727     10.742640
## 19        606.0815       24362.259        591.1981     44.184754
## 20        654.2852       39682.512        643.3536     45.162371
## 21        868.1137       28836.543        842.3096     38.566016
## 22        878.1553       25979.214        848.4122     31.067847
## 23       1319.4173       28851.846       1259.6298     23.068875
## 24       1425.5540       22022.754       1335.4046     16.426751
## 25        894.7508       28059.227        866.4363     28.574285
## 26       1161.4828       23963.823       1106.9121     17.297594
## 27        618.0858       15687.806        594.2792     28.458342
## 28       1936.2534       24998.413       1792.7483     12.919119
## 29       2257.3263       28398.816       2081.8578     13.894526
## 30       1698.8270       17855.661       1550.0963      9.325417
## 31        791.8716       27776.124        769.6655     33.162803
## 32       1417.7577       27237.340       1346.4507     22.274396
## 33       1969.5744       29548.351       1843.6675     14.249844
## 34       2278.4535       26438.764       2091.4543     11.378845
## 35       2319.8812        6961.079       1735.4050      2.973534
## 36       1155.6296       29137.311       1110.8280     23.281641
## 37        878.4006       30680.211        853.4403     30.331434
## 38        651.8946       20834.018        631.5534     31.244920
##    Efisiensi_com
## 1      0.9716358
## 2      0.9581945
## 3      0.9738372
## 4      0.9774653
## 5      0.9726571
## 6      0.9618634
## 7      0.8380448
## 8      0.9618224
## 9      0.9699388
## 10     0.9741652
## 11     0.9694136
## 12     0.9743443
## 13     0.9480524
## 14     0.9769516
## 15     0.9755807
## 16     0.9698797
## 17     0.9436799
## 18     0.9139109
## 19     0.9775778
## 20     0.9776666
## 21     0.9742262
## 22     0.9676404
## 23     0.9567214
## 24     0.9399847
## 25     0.9652924
## 26     0.9443496
## 27     0.9654856
## 28     0.9255271
## 29     0.9284872
## 30     0.9023274
## 31     0.9703362
## 32     0.9561148
## 33     0.9326015
## 34     0.9159002
## 35     0.7463040
## 36     0.9580039
## 37     0.9673153
## 38     0.9680503

Rata-rata efisiensi:

rt_syn_3_0.7 <- mean(res_srs2_0.7$Efisiensi_syn)
rt_com_3_0.7 <- mean(res_srs2_0.7$Efisiensi_com)
rt_syn_3_0.7
## [1] 26.86904
rt_com_3_0.7
## [1] 0.9492461
      e. f = 60%
res_srs2_0.6
##    kab   Y dir   Y syn   Y com     MSE dir     MSE syn     MSE com
## 1    1 1637125 1481263 1630286  2432317862 56517675569  2323865057
## 2   10 2442475 2650665 2455253  3326979523 49925702303  3112879623
## 3   11 1435409 1733680 1446777  2238408231 55021997217  2145379709
## 4   12 1629303 2068771 1644109  1898138253 54200200334  1831411203
## 5   13 1658375 1449978 1649989  2164763509 53507154949  2076050669
## 6   14 2671724 2614621 2668259  2986526338 51138644949  2816220246
## 7   15 5042676 4861605 5000073 14460204278 50453143497 11173356912
## 8   16 2701020 2592868 2694443  3360105578 54261806956  3159185673
## 9   17 2055988 2275982 2065515  2439361931 53291577061  2329660938
## 10  18 1792728 1715722 1789662  2131641831 54179613033  2048911138
## 11  19 1891422 2263225 1907596  2548754453 55002470985  2430616081
## 12   2 1628454 1468033 1622117  2188186217 54963340881  2102115559
## 13  20 1923350 1536237 1894004  4454728760 55689111144  4111385163
## 14  21 1543163 1867603 1554181  1924402860 54404649951  1856628523
## 15  22 2019101 1854907 2013080  1951645087 52561808385  1880456010
## 16  23 2142448 2559339 2160977  2494643483 53313251309  2380536300
## 17  24 2729487 2697062 2726387  4723588130 53356522165  4317401376
## 18  25 3922827 3722517 3896910  7802823189 53571323662  6799494465
## 19  26 2043439 2256585 2050535  1902244029 55177275408  1837759684
## 20  27 1852547 1379604 1835850  1995383757 54943737009  1922923954
## 21  28 1634403 1900488 1644707  2226091068 54963340881  2137083607
## 22  29 1942268 2051001 1947513  2718368705 53334899677  2579585076
## 23   3 1791882 1896537 1797557  3628497038 55002470985  3389055374
## 24   4 2290768 2445637 2302778  5064236234 54117695855  4598311475
## 25   5 2078041 1897898 2068438  2924851972 53549959971  2769263386
## 26   6 2527656 2118070 2493926  4466962920 50969171744  4097514120
## 27   7 2717802 3043751 2734931  2648784844 47866713495  2506412808
## 28  71 2306319 2314112 2305808  7082780833 58159587156  6274309373
## 29  72 1872780 2081697 1892277  6671417653 59458955055  5935945393
## 30  73 3492940 3096595 3435741  9212498797 55482862887  7885046584
## 31  74 2195801 2088779 2190778  2736142398 58320571820  2610920541
## 32  75 1881399 2160321 1899898  4305908258 59182249320  4004542558
## 33  76 2084319 1998623 2075178  6376210063 59397167275  5734591506
## 34  77 2265535 2227815 2259610  8047452479 59233491122  7038007918
## 35  78 7024052 6960825 7001825 25461538178 48355839796 16617052404
## 36  79 2172091 2011942 2161470  3968819025 58959852131  3709060557
## 37   8 2009752 1754196 1997289  2691152157 54158999854  2559268318
## 38   9 2269548 2221866 2267145  2242812812 46406580910  2136262624
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1        1476.6873       38176.365       1417.6537     23.236139
## 2        1359.8559       18834.519       1265.8878     15.006315
## 3        1550.1921       31742.327       1474.2693     24.580859
## 4        1161.9542       26203.381       1110.9754     28.554401
## 5        1299.4069       36924.495       1253.0612     24.717321
## 6        1115.9124       19556.272       1053.8561     17.123119
## 7        2860.4724       10376.717       2231.1222      3.489103
## 8        1242.2405       20926.149       1171.0147     16.148840
## 9        1184.5723       23413.656       1126.1543     21.846523
## 10       1187.1683       31582.541       1143.2014     25.416846
## 11       1342.2806       24302.303       1269.3317     21.580137
## 12       1340.1701       37451.281       1292.7812     25.118219
## 13       2306.3062       36261.106       2163.4461     12.501123
## 14       1244.1908       29132.968       1191.9042     28.270926
## 15        965.4745       28338.285        933.1292     26.932053
## 16       1162.3309       20829.436       1099.7462     21.371090
## 17       1724.9387       19785.100       1579.0208     11.295761
## 18       1986.6629       14389.895       1743.1204      6.865633
## 19        930.1787       24455.559        895.5628     29.006413
## 20       1074.4625       39862.907       1045.2153     27.535424
## 21       1359.5719       28926.830       1297.1172     24.690518
## 22       1394.3780       26013.177       1319.7688     19.620186
## 23       2011.2003       29007.218       1873.6603     15.158472
## 24       2197.0543       22126.920       1985.8257     10.686250
## 25       1404.2353       28220.131       1336.0667     18.308605
## 26       1763.0884       24065.112       1639.9031     11.410252
## 27        973.4781       15728.554        915.4542     18.071197
## 28       3054.4522       25137.293       2708.9048      8.211406
## 29       3531.9218       28569.473       3112.4187      8.912492
## 30       2633.4185       17917.358       2292.4277      6.022564
## 31       1244.2972       27927.524       1190.2497     21.314889
## 32       2280.7934       27401.126       2101.1199     13.744429
## 33       3043.9774       29727.326       2751.9958      9.315435
## 34       3534.3066       26593.116       3102.0416      7.360527
## 35       3621.7353        6946.143       2371.8589      1.899172
## 36       1820.2661       29312.999       1710.3398     14.855767
## 37       1335.1232       30882.841       1278.1098     20.124838
## 38        985.8628       20889.040        940.1938     20.691241
##    Efisiensi_com
## 1      0.9554117
## 2      0.9356474
## 3      0.9584399
## 4      0.9648461
## 5      0.9590196
## 6      0.9429752
## 7      0.7726970
## 8      0.9402043
## 9      0.9550288
## 10     0.9611892
## 11     0.9536486
## 12     0.9606658
## 13     0.9229260
## 14     0.9647816
## 15     0.9635236
## 16     0.9542591
## 17     0.9140089
## 18     0.8714147
## 19     0.9661009
## 20     0.9636863
## 21     0.9600163
## 22     0.9489460
## 23     0.9340108
## 24     0.9079970
## 25     0.9468046
## 26     0.9172931
## 27     0.9462501
## 28     0.8858539
## 29     0.8897577
## 30     0.8559075
## 31     0.9542342
## 32     0.9300111
## 33     0.8993731
## 34     0.8745635
## 35     0.6526335
## 36     0.9345502
## 37     0.9509935
## 38     0.9524926

Rata-rata efisiensi:

rt_syn_3_0.6 <- mean(res_srs2_0.6$Efisiensi_syn)
rt_com_3_0.6 <- mean(res_srs2_0.6$Efisiensi_com)
rt_syn_3_0.6
## [1] 17.39459
rt_com_3_0.6
## [1] 0.9242675
      f. f = 50%
res_srs2_0.5
##    kab   Y dir   Y syn   Y com     MSE dir     MSE syn     MSE com
## 1    1 1634292 1483976 1624700  3647159434 58836870350  3408243472
## 2   10 2454318 2651805 2471167  5077949491 52583093099  4609683673
## 3   11 1424265 1734276 1440096  3183109192 57417926603  2999312158
## 4   12 1631493 2069023 1652269  2821429692 56638291363  2678953935
## 5   13 1658537 1448071 1646590  3182679716 55980802128  2998575443
## 6   14 2679847 2614598 2674106  4626282269 53733806675  4241722082
## 7   15 5061372 4865367 5000640 22191612229 53083474337 15504297975
## 8   16 2703903 2596243 2694650  4967391133 56696737306  4550954334
## 9   17 2055037 2277704 2068559  3729544690 55776284295  3483983773
## 10  18 1797858 1717613 1793061  3233577355 56618760278  3050250917
## 11  19 1890713 2266030 1914176  3903725208 57399402148  3641090763
## 12   2 1634902 1470070 1625299  3385973696 57362279583  3189165397
## 13  20 1937447 1538309 1892800  7139104612 58050814773  6328891270
## 14  21 1536018 1868973 1551944  2881449270 56832251853  2736921589
## 15  22 2027255 1856353 2018220  2975122800 55083955828  2818330775
## 16  23 2144106 2561757 2170459  3776700052 55796846562  3528862976
## 17  24 2722045 2699128 2718315  6674639299 55837897440  5885256113
## 18  25 3923728 3725649 3888715 11662098725 56041678715  9613575544
## 19  26 2041433 2253770 2051182  2820994939 57565238368  2685071169
## 20  27 1845328 1374467 1823066  2808069690 57343681473  2668076745
## 21  28 1627384 1896094 1641782  3306080090 57362279583  3118851200
## 22  29 1940171 2044393 1946811  3982806073 55817384277  3694080845
## 23   3 1794141 1897924 1802065  5591362677 57399402148  5048918382
## 24   4 2296178 2447393 2313059  7927137605 56560019712  6880452897
## 25   5 2085535 1898391 2071137  4427734487 56021411072  4089004529
## 26   6 2506643 2119212 2462851  6576632460 53573028159  5828353120
## 27   7 2709186 3044986 2733673  3911427478 50629739097  3617750264
## 28  71 2294160 2317185 2294788 10321504318 60394544952  8703897305
## 29  72 1892722 2084599 1916068 10233846727 61627249800  8600197866
## 30  73 3480838 3098179 3405577 13925812961 57855147921 11184353528
## 31  74 2193458 2091308 2186689  4087433877 60547270424  3822462023
## 32  75 1875600 2163501 1901665  6354774308 61364740235  5726425190
## 33  76 2101706 2001566 2086348  9631534275 61568631994  8258817163
## 34  77 2259258 2230756 2250225 12064502278 61413353118  9910844319
## 35  78 7018980 6956897 6991815 37973125753 51093771156 21612799577
## 36  79 2187444 2014991 2171100  5997515917 61153752960  5434777161
## 37   8 2016385 1755735 1998163  4096364878 56599204641  3809574271
## 38   9 2273403 2220801 2269683  3377397073 49244517468  3147663265
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         2210.450       39675.972        2080.711     16.132245
## 2         2063.313       19833.283        1861.059     10.355182
## 3         2218.759       33111.832        2067.788     18.038315
## 4         1723.415       27379.821        1615.660     20.074323
## 5         1904.951       38681.517        1809.586     17.589204
## 6         1721.771       20546.586        1582.642     11.614900
## 7         4371.784       10910.157        3095.508      2.392051
## 8         1832.545       21835.650        1685.359     11.413786
## 9         1808.152       24486.672        1678.577     14.955253
## 10        1791.634       32969.043        1695.322     17.509635
## 11        2055.742       25328.202        1894.381     14.703751
## 12        2063.664       39035.120        1956.061     16.941147
## 13        3665.901       37748.500        3330.962      8.131386
## 14        1868.389       30411.965        1756.657     19.723496
## 15        1465.242       29671.282        1394.450     18.514851
## 16        1756.705       21777.388        1621.809     14.773968
## 17        2435.458       20683.552        2152.572      8.365680
## 18        2966.801       15039.440        2468.706      4.805454
## 19        1378.556       25546.482        1306.132     20.406006
## 20        1514.199       41763.149        1457.599     20.421032
## 21        2022.699       30255.120        1891.869     17.350541
## 22        2040.656       27308.416        1887.060     14.014588
## 23        3093.870       30252.016        2784.204     10.265727
## 24        3430.672       23108.647        2958.610      7.134986
## 25        2115.321       29520.402        1968.247     12.652387
## 26        2614.002       25290.115        2359.834      8.145967
## 27        1441.660       16636.527        1321.610     12.944057
## 28        4463.613       26070.448        3770.731      5.851332
## 29        5330.888       29572.289        4434.693      6.021905
## 30        3987.549       18672.852        3276.176      4.154526
## 31        1860.595       28960.320        1745.747     14.813028
## 32        3371.640       28371.970        2998.699      9.656478
## 33        4546.251       30771.690        3934.097      6.392401
## 34        5273.950       27536.586        4364.423      5.090417
## 35        5404.877        7345.409        3089.768      1.345525
## 36        2729.357       30360.467        2494.003     10.196514
## 37        2024.138       32248.610        1900.637     13.816934
## 38        1481.813       22195.247        1383.738     14.580612
##    Efisiensi_com
## 1      0.9344926
## 2      0.9077845
## 3      0.9422586
## 4      0.9495023
## 5      0.9421543
## 6      0.9168749
## 7      0.6986558
## 8      0.9161659
## 9      0.9341579
## 10     0.9433054
## 11     0.9327221
## 12     0.9418754
## 13     0.8865105
## 14     0.9498420
## 15     0.9472990
## 16     0.9343773
## 17     0.8817340
## 18     0.8243435
## 19     0.9518171
## 20     0.9501462
## 21     0.9433683
## 22     0.9275071
## 23     0.9029853
## 24     0.8679618
## 25     0.9234981
## 26     0.8862215
## 27     0.9249181
## 28     0.8432780
## 29     0.8403681
## 30     0.8031383
## 31     0.9351740
## 32     0.9011217
## 33     0.8574768
## 34     0.8214880
## 35     0.5691604
## 36     0.9061714
## 37     0.9299890
## 38     0.9319790

Rata-rata efisiensi:

rt_syn_3_0.5 <- mean(res_srs2_0.5$Efisiensi_syn)
rt_com_3_0.5 <- mean(res_srs2_0.5$Efisiensi_com)
rt_syn_3_0.5
## [1] 12.1392
rt_com_3_0.5
## [1] 0.8947849
      g. f = 40%
res_srs2_0.4
##    kab   Y dir   Y syn   Y com     MSE dir     MSE syn     MSE com
## 1    1 1635985 1484912 1621941  5615293161 61870209985  5068604686
## 2   10 2443283 2653746 2466562  7489420770 55916262923  6545186097
## 3   11 1424325 1736256 1446874  5002347393 60519295871  4568442002
## 4   12 1629233 2070789 1657009  4069231756 59777039350  3786226470
## 5   13 1652100 1449692 1635219  4858024477 59151072684  4437277280
## 6   14 2672777 2615155 2664833  7063352890 57011806854  6224194524
## 7   15 5064000 4865144 4987217 32992121833 56392653955 20526526636
## 8   16 2710265 2597037 2695994  7523780042 59832683169  6631782953
## 9   17 2064182 2279647 2082984  5878240231 58956360224  5317332143
## 10  18 1810041 1719849 1802338  5031762593 59758444661  4622238874
## 11  19 1890016 2267496 1922036  5792774117 60501659550  5244361374
## 12   2 1637618 1472542 1624155  5109517373 60466316785  4692097040
## 13  20 1924560 1540109 1867380 10046872548 61121840942  8515784620
## 14  21 1551494 1871542 1573125  4466287293 59961700627  4136178215
## 15  22 2014916 1858605 2003553  4350353069 58297224652  4037416080
## 16  23 2145654 2562562 2181964  5678373744 58975936656  5156825025
## 17  24 2715231 2698208 2710348 10711202017 59015019398  8857162970
## 18  25 3932662 3724328 3882487 17678329380 59209030613 13501128311
## 19  26 2050440 2256767 2063961  4285804397 60659544942  3993000992
## 20  27 1853886 1376861 1821468  4353562993 60448610339  4036867668
## 21  28 1633092 1897509 1652775  4971697907 60466316785  4575421177
## 22  29 1938458 2042313 1947919  5998671534 58995489714  5374646775
## 23   3 1808919 1899916 1818306  9117821237 60501659550  7815810656
## 24   4 2301896 2449221 2321830 12111593301 59702520344  9845241015
## 25   5 2074651 1900966 2056139  6457701926 59189734678  5776148810
## 26   6 2527342 2122462 2462720 10277315076 56858736680  8623410787
## 27   7 2713645 3045620 2746444  5866126178 54056560241  5262636117
## 28  71 2293523 2317577 2294217 15211860569 63353203662 12000334193
## 29  72 1892051 2085300 1924079 15708995387 64526807889 12252177811
## 30  73 3500227 3098180 3395677 20803931498 60935555114 15390325736
## 31  74 2194578 2091857 2184760  6045416467 63498606887  5496943917
## 32  75 1850161 2163983 1887639  9215147864 64276884044  7986493711
## 33  76 2093224 2002245 2072575 14126099819 64471000446 11385765688
## 34  77 2296378 2231321 2275921 19572434907 64323166237 14661557155
## 35  78 7010811 6958992 6982847 56491753131 54498344815 27414919492
## 36  79 2159707 2015634 2141184  8550169849 64076012312  7480758353
## 37   8 2020015 1756908 1993644  6274025719 59739826597  5637579187
## 38   9 2274504 2224602 2269295  5138366174 52737751477  4648027611
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         3388.179        41698.98        3093.291    11.0181620
## 2         3046.889        21073.05        2640.533     7.4660330
## 3         3469.176        34863.88        3120.037    12.0981793
## 4         2481.516        28870.03        2269.916    14.6900061
## 5         2907.209        40843.36        2689.216    12.1759520
## 6         2628.751        21806.13        2325.953     8.0714935
## 7         6485.244        11593.70        4105.890     1.7092764
## 8         2762.021        23040.50        2450.517     7.9524764
## 9         2835.042        25865.54        2542.658    10.0295935
## 10        2766.997        34756.58        2554.445    11.8762449
## 11        3043.259        26682.94        2710.431    10.4443326
## 12        3105.263        41087.17        2877.429    11.8340564
## 13        5161.945        39700.39        4527.240     6.0836684
## 14        2860.277        32044.03        2613.560    13.4254016
## 15        2153.226        31392.90        2010.436    13.4005732
## 16        2638.041        23017.08        2356.587    10.3860611
## 17        3911.075        21892.72        3247.307     5.5096542
## 18        4481.190        15903.09        3470.637     3.3492435
## 19        2085.420        26892.11        1930.621    14.1535962
## 20        2334.165        43972.54        2206.544    13.8848595
## 21        3029.558        31883.18        2756.326    12.1621060
## 22        3067.985        28943.25        2737.541     9.8347591
## 23        4987.266        31848.25        4261.087     6.6355391
## 24        5198.560        24377.15        4201.678     4.9293696
## 25        3092.532        31142.81        2795.411     9.1657582
## 26        4041.432        26795.47        3486.885     5.5324505
## 27        2156.048        17756.09        1911.713     9.2150354
## 28        6560.160        27340.69        5189.365     4.1647242
## 29        8187.052        30949.85        6297.393     4.1076343
## 30        5914.302        19669.74        4518.943     2.9290404
## 31        2744.574        30361.20        2508.536    10.5035951
## 32        4945.213        29709.05        4207.270     6.9751332
## 33        6650.109        32207.65        5437.684     4.5639633
## 34        8429.885        28831.13        6397.936     3.2864162
## 35        8041.461         7838.33        3924.482     0.9647133
## 36        3935.168        31797.45        3477.957     7.4941216
## 37        3085.786        34016.40        2813.812     9.5217695
## 38        2247.644        23718.44        2039.443    10.2635253
##    Efisiensi_com
## 1      0.9026429
## 2      0.8739242
## 3      0.9132596
## 4      0.9304524
## 5      0.9133913
## 6      0.8811955
## 7      0.6221645
## 8      0.8814430
## 9      0.9045789
## 10     0.9186123
## 11     0.9053281
## 12     0.9183053
## 13     0.8476055
## 14     0.9260887
## 15     0.9280663
## 16     0.9081517
## 17     0.8269065
## 18     0.7637106
## 19     0.9316806
## 20     0.9272561
## 21     0.9202935
## 22     0.8959728
## 23     0.8572016
## 24     0.8128774
## 25     0.8944589
## 26     0.8390723
## 27     0.8971229
## 28     0.7888801
## 29     0.7799466
## 30     0.7397797
## 31     0.9092746
## 32     0.8666702
## 33     0.8060091
## 34     0.7490921
## 35     0.4852906
## 36     0.8749251
## 37     0.8985585
## 38     0.9045731

Rata-rata efisiensi:

rt_syn_3_0.4 <- mean(res_srs2_0.4$Efisiensi_syn)
rt_com_3_0.4 <- mean(res_srs2_0.4$Efisiensi_com)
rt_syn_3_0.4
## [1] 8.468645
rt_com_3_0.4
## [1] 0.8564411
      h. f = 30%
res_srs2_0.3
##    kab   Y dir   Y syn   Y com     MSE dir     MSE syn     MSE com
## 1    1 1628704 1480832 1608853  8398705154 67953404352  7222706064
## 2   10 2447272 2653771 2478311 11898135371 62368866494  9809316804
## 3   11 1454864 1733497 1484160  8766590353 66686306923  7553407622
## 4   12 1610511 2066415 1650059  6380264226 65990103279  5739910763
## 5   13 1677556 1452199 1648578  8463151804 65402974353  7335547857
## 6   14 2675051 2612459 2663798 10661839563 63396438035  8945165351
## 7   15 5025055 4847789 4937668 50021689503 62815700120 27076444419
## 8   16 2707267 2588445 2686806 11824966680 66042294709  9884309949
## 9   17 2055552 2275814 2079239  8768602052 65220342714  7608834177
## 10  18 1807191 1717882 1796282  7632632319 65972662286  6760117472
## 11  19 1875708 2259356 1917365  8542732824 66669764838  7443537504
## 12   2 1616163 1471233 1600282  7347192758 66636614893  6551107612
## 13  20 1939387 1536300 1854220 16970122572 67251467434 13271908893
## 14  21 1524842 1868563 1553366  6265088987 66163307353  5642898758
## 15  22 2025354 1855099 2007237  7098752350 64602102828  6342893779
## 16  23 2137048 2554785 2184908  8607852055 65238704539  7510888331
## 17  24 2705014 2686575 2697827 14384172251 65275362414 11285989746
## 18  25 3916253 3707607 3852330 27320658717 65457336315 19032056968
## 19  26 2038781 2253027 2058349  6801606592 66817854321  6132965972
## 20  27 1852340 1378899 1804630  7238479013 66620007034  6434031067
## 21  28 1622965 1897561 1650156  7544241092 66636614893  6717204920
## 22  29 1938588 2049217 1952077  9751086600 65257044439  8193819176
## 23   3 1780209 1896239 1793061 11810941037 66669764838  9729645052
## 24   4 2297735 2443800 2322596 17988199005 65920207761 13541890644
## 25   5 2077302 1901315 2050969 10083301538 65439237585  8626929775
## 26   6 2536384 2123836 2446563 16577925967 63252865012 12932119310
## 27   7 2715204 3047707 2760289  9297420178 60624547990  7956182482
## 28  71 2298738 2306208 2292509 25188971593 69344386543 17741233692
## 29  72 1855747 2074494 1891938 22244149141 70445175173 15616486108
## 30  73 3481010 3089367 3350382 31796826493 67076739601 21267638470
## 31  74 2205340 2081860 2188724  9766068708 69480768308  8487918436
## 32  75 1863324 2152664 1907429 14037600435 70210757709 11441000176
## 33  76 2094169 1991805 2062383 22069169268 70392830271 16181578014
## 34  77 2246969 2220291 2228833 28816551894 70254168351 19519386537
## 35  78 7017355 6949227 6975326 87430705924 61038922295 35336715945
## 36  79 2172494 2005499 2142176 13674581772 70022348948 11242593976
## 37   8 2020552 1755585 1983182  9980441811 65955199369  8566422381
## 38   9 2277091 2233868 2269812  8028505580 59387563953  6951142178
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         5054.848       45943.437        4429.042     8.0909382
## 2         4826.351       23502.792        3935.636     5.2419026
## 3         5918.330       38478.080        5008.656     7.6068693
## 4         3923.647       31935.794        3445.502    10.3428480
## 5         4958.947       45108.161        4394.860     7.7279689
## 6         3959.895       24269.798        3342.833     5.9461069
## 7         9877.880       12957.371        5468.120     1.2557693
## 8         4343.312       25509.176        3664.633     5.5849878
## 9         4224.204       28655.222        3630.517     7.4379408
## 10        4193.002       38420.149        3742.442     8.6435006
## 11        4501.430       29505.630        3841.022     7.8042666
## 12        4514.789       45348.188        4071.653     9.0696702
## 13        8607.677       43803.636        7085.870     3.9629335
## 14        4053.073       35419.239        3586.880    10.5606333
## 15        3488.526       34856.447        3148.361     9.1004869
## 16        4002.034       25531.874        3418.951     7.5789760
## 17        5246.842       24317.391        4146.761     4.5379992
## 18        6949.845       17655.585        4928.445     2.3958916
## 19        3323.340       29671.293        2969.574     9.8238340
## 20        3852.309       48449.922        3528.924     9.2035919
## 21        4613.722       35149.729        4044.944     8.8327791
## 22        4946.724       31964.528        4137.765     6.6922844
## 23        6531.527       35162.511        5361.398     5.6447462
## 24        7729.826       26970.596        5775.429     3.6646363
## 25        4805.869       34423.810        4176.490     6.4898622
## 26        6469.819       29792.627        5253.710     3.8154872
## 27        3411.106       19906.652        2873.384     6.5205774
## 28       10749.895       30071.532        7648.947     2.7529662
## 29       11576.491       33967.383        8065.734     3.1669081
## 30        9072.067       21714.396        6325.812     2.1095420
## 31        4403.924       33383.707        3861.334     7.1145074
## 32        7446.232       32623.072        5946.309     5.0016210
## 33       10329.443       35354.991        7749.940     3.1896457
## 34       12538.078       31647.410        8649.864     2.4379797
## 35       12419.512        8792.211        5062.441     0.6981406
## 36        6233.696       34927.596        5214.578     5.1206209
## 37        4898.261       37589.431        4293.366     6.6084449
## 38        3506.259       26607.404        3050.191     7.3970882
##    Efisiensi_com
## 1      0.8599785
## 2      0.8244415
## 3      0.8616129
## 4      0.8996353
## 5      0.8667631
## 6      0.8389889
## 7      0.5412941
## 8      0.8358848
## 9      0.8677363
## 10     0.8856862
## 11     0.8713298
## 12     0.8916477
## 13     0.7820750
## 14     0.9006893
## 15     0.8935223
## 16     0.8725624
## 17     0.7846117
## 18     0.6966178
## 19     0.9016937
## 20     0.8888651
## 21     0.8903752
## 22     0.8402981
## 23     0.8237824
## 24     0.7528208
## 25     0.8555660
## 26     0.7800807
## 27     0.8557409
## 28     0.7043254
## 29     0.7020492
## 30     0.6688604
## 31     0.8691234
## 32     0.8150253
## 33     0.7332210
## 34     0.6773672
## 35     0.4041683
## 36     0.8221527
## 37     0.8583210
## 38     0.8658077

Rata-rata efisiensi:

rt_syn_3_0.3 <- mean(res_srs2_0.3$Efisiensi_syn)
rt_com_3_0.3 <- mean(res_srs2_0.3$Efisiensi_com)
rt_syn_3_0.3
## [1] 6.03092
rt_com_3_0.3
## [1] 0.8074927
      i. f = 20%
res_srs2_0.2
##    kab   Y dir   Y syn   Y com      MSE dir     MSE syn     MSE com
## 1    1 1636202 1481666 1605574  14572545244 74915609232 11441008138
## 2   10 2446665 2652868 2485212  20001752276 69913380752 14939850454
## 3   11 1417673 1729914 1458160  12816346281 73780634234 10472118713
## 4   12 1616938 2061117 1671958  10762754056 73157024942  9147267382
## 5   13 1635462 1438544 1601672  12733635533 72631116960 10444473677
## 6   14 2673866 2610873 2657216  16602009048 70833805639 13051914020
## 7   15 5085111 4863610 4957197  88623745643 70313622267 38106590172
## 8   16 2703177 2597244 2674543  19636376252 73203774282 15077104497
## 9   17 2084702 2278620 2113976  15320312578 72467528637 12344680282
## 10  18 1788705 1719188 1775035  12943817775 73141402552 10773919079
## 11  19 1890455 2265483 1948783  15222832622 73765817020 12197687065
## 12   2 1636162 1472639 1608059  12755913040 73736123677 10642245530
## 13  20 1904382 1536712 1800731  26216597936 74286864485 18503788547
## 14  21 1549447 1868566 1588901  11537995417 73312168730  9673383459
## 15  22 2027927 1859389 2001198  12275742962 71913753689 10342937723
## 16  23 2139092 2560774 2208317  14975880969 72483975843 12202923049
## 17  24 2684891 2696039 2676653  27119655841 72516811338 17880876024
## 18  25 3941422 3720543 3848166  47438228161 72679810507 27909632172
## 19  26 2031133 2241181 2057625  11132858176 73898464958  9569602236
## 20  27 1840008 1354789 1773759  11418601491 73721247548  9612582887
## 21  28 1610492 1878695 1647136  12396717677 73736123677 10424587345
## 22  29 1931315 2026521 1947552  16174169563 72500403410 12523555766
## 23   3 1784157 1893897 1798372  21400938990 73765817020 15583555793
## 24   4 2319251 2446761 2339475  35058309618 73094417550 21487212822
## 25   5 2090102 1896221 2045930  18116413384 72663598963 14044745458
## 26   6 2524980 2122393 2405993  27558232708 70705203222 19153323943
## 27   7 2693459 3046031 2758388  15456068590 68350945343 12377629430
## 28  71 2296368 2309874 2286259  40205739987 76161551315 24671438197
## 29  72 1874180 2077123 1907861  42091333916 77147558819 23197150126
## 30  73 3500473 3092016 3321623  54628848415 74130355824 30641574068
## 31  74 2205154 2083299 2181125  15583358454 76283712319 12749540468
## 32  75 1861248 2156380 1922419  24740361743 76937584468 17921842617
## 33  76 2089428 1994162 2047771  37673504866 77100672010 23783462301
## 34  77 2233458 2223572 2211861  44814192212 76976468607 26454688933
## 35  78 6985679 6948383 6957376 152322296477 68722112126 46520312731
## 36  79 2160215 2008181 2116222  24287997701 76768821412 17775519066
## 37   8 2014679 1753451 1960706  16906371134 73125760523 13333928425
## 38   9 2282664 2224002 2270106  14175749991 67242943761 11428317875
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         8652.927       50640.952        7020.680     5.1408733
## 2         8054.468       26353.187        5954.723     3.4953628
## 3         8810.268       42666.264        7017.788     5.7567604
## 4         6589.613       35505.836        5420.307     6.7972402
## 5         7603.301       50557.439        6420.790     5.7038791
## 6         6150.133       27113.957        4884.546     4.2665804
## 7        17293.798       14449.403        7662.614     0.7933948
## 8         7174.811       28170.370        5597.264     3.7279676
## 9         7261.415       31796.926        5788.860     4.7301599
## 10        7151.400       42580.639        6018.718     5.6506823
## 11        7908.498       32562.707        6163.273     4.8457353
## 12        7664.719       50177.835        6540.493     5.7805446
## 13       13365.170       48402.699       10140.657     2.8335814
## 14        7305.425       39273.874        5994.835     6.3539780
## 15        6002.197       38729.394        5135.192     5.8581997
## 16        6942.762       28289.716        5487.522     4.8400475
## 17        9757.869       26903.222        6547.304     2.6739577
## 18       11957.781       19518.341        7234.987     1.5320937
## 19        5445.168       33001.317        4625.347     6.6378700
## 20        6094.335       54567.661        5365.362     6.4562414
## 21        7611.914       39274.354        6268.769     5.9480361
## 22        8155.034       35937.199        6287.033     4.4824807
## 23       11661.067       38976.688        8502.025     3.4468496
## 24       14651.390       29872.432        9019.046     2.0849384
## 25        8537.517       38348.144        6809.153     4.0109263
## 26       10753.874       33351.030        7908.280     2.5656654
## 27        5705.146       22446.474        4467.680     4.4222724
## 28       16992.632       32974.344       10645.929     1.8942955
## 29       20951.851       37159.894       11737.233     1.8328609
## 30       15415.309       23990.092        9177.059     1.3569819
## 31        7001.616       36633.143        5808.390     4.8952036
## 32       13003.567       35688.872        9194.998     3.1098003
## 33       17539.763       38688.178       11456.511     2.0465490
## 34       19440.603       34631.704       11803.220     1.7176806
## 35       21697.415        9904.614        6683.741     0.4511625
## 36       11043.118       38251.344        8323.151     3.1607719
## 37        8259.027       41726.906        6735.620     4.3253375
## 38        6139.166       30266.930        4992.772     4.7435193
##    Efisiensi_com
## 1      0.7851071
## 2      0.7469271
## 3      0.8170908
## 4      0.8499003
## 5      0.8202272
## 6      0.7861647
## 7      0.4299817
## 8      0.7678150
## 9      0.8057721
## 10     0.8323602
## 11     0.8012758
## 12     0.8342990
## 13     0.7058043
## 14     0.8383938
## 15     0.8425509
## 16     0.8148384
## 17     0.6593327
## 18     0.5883363
## 19     0.8595818
## 20     0.8418354
## 21     0.8409151
## 22     0.7742936
## 23     0.7281716
## 24     0.6128993
## 25     0.7752498
## 26     0.6950128
## 27     0.8008265
## 28     0.6136298
## 29     0.5511146
## 30     0.5609046
## 31     0.8181510
## 32     0.7243970
## 33     0.6313047
## 34     0.5903194
## 35     0.3054071
## 36     0.7318643
## 37     0.7886925
## 38     0.8061879

Rata-rata efisiensi:

rt_syn_3_0.2 <- mean(res_srs2_0.2$Efisiensi_syn)
rt_com_3_0.2 <- mean(res_srs2_0.2$Efisiensi_com)
rt_syn_3_0.2
## [1] 3.957118
rt_com_3_0.2
## [1] 0.730972
      j. f = 10%
res_srs2_0.1
##    kab   Y dir   Y syn   Y com      MSE dir      MSE syn     MSE com
## 1    1 1651737 1475670 1600879  34192283666 102897607107 22473908721
## 2   10 2456110 2642080 2500658  46315363403  99918228231 29430969047
## 3   11 1442237 1723227 1487522  33338750410 102221604292 21984425106
## 4   12 1596365 2049804 1673534  23562803397 101850176166 18016040229
## 5   13 1663225 1444868 1600412  31735802158 101536939948 21693719808
## 6   14 2653677 2607601 2624305  38276980280 100466442787 25469555855
## 7   15 5109561 4841286 4914023 200453584817 100156616205 61789577717
## 8   16 2692387 2585466 2649165  44356568288 101878020555 29020971154
## 9   17 2037823 2269626 2082362  33210569697 101439505055 23424621845
## 10  18 1779507 1710482 1756712  27499744705 101840871309 20494831969
## 11  19 1888606 2250105 1955779  34509820648 102212779007 23541225980
## 12   2 1613718 1463547 1573831  27968584075 102195093346 20707599870
## 13  20 1920884 1527194 1756094  64932688501 102523120251 35313326067
## 14  21 1512527 1855415 1566121  23920546731 101942581406 18112234885
## 15  22 2016962 1853833 1976407  27108579913 101109670984 20605743639
## 16  23 2145624 2551191 2238261  32304043717 101449301180 23663252352
## 17  24 2711322 2701713 2691772  60865777169 101468858340 32147593686
## 18  25 3896691 3712241 3788719 103774964093 101565942326 48593425033
## 19  26 2027224 2231518 2065228  25115934530 102291785487 19705582531
## 20  27 1835198 1361115 1739086  24855907783 102186232970 18300252355
## 21  28 1615265 1877334 1662400  27762762152 102195093346 20533979159
## 22  29 1936066 2031757 1956062  36508903327 101459085609 23498804695
## 23   3 1814353 1881559 1801231  56046873210 102212779007 30797688872
## 24   4 2277054 2432404 2300229  74688513919 101812886558 35848674425
## 25   5 2085644 1887112 2013695  44018781586 101556286564 28459974301
## 26   6 2515348 2107882 2338474  63894087092 100389845861 35885894623
## 27   7 2675396 3048719 2770183  32707486138  98987625586 23786889594
## 28  71 2250029 2293986 2234517  81834232211 103639703063 39762884474
## 29  72 1841602 2060501 1877222  97052474214 104226979302 38228988745
## 30  73 3516720 3069322 3258383 125593321784 102429902079 53643547194
## 31  74 2193817 2068142 2154281  36769038865 103712463416 26160874352
## 32  75 1828400 2140212 1905764  55353149538 104101916413 32979964233
## 33  76 2105634 1978184 2019841  87618226192 104199053035 41851242782
## 34  77 2162940 2205912 2140735  90931091100 104125076207 41658912259
## 35  78 6920687 6893963 6897162 329813291988  99208696350 74057442910
## 36  79 2149536 1992501 2092019  45019414856 104001399396 29083759676
## 37   8 1979416 1749237 1907295  34394179861 101831554756 23220373858
## 38   9 2277855 2220438 2256552  29463295232  98327688416 21043904905
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         19739.10        69910.20       13812.822     3.0093810
## 2         18413.74        37769.63       11627.420     2.1573452
## 3         21703.46        59338.84       14151.695     3.0661498
## 4         14405.41        49664.52       10540.101     4.3224982
## 5         18215.42        70621.02       13279.104     3.1994446
## 6         13989.84        38539.47        9602.475     2.6247223
## 7         38239.17        20689.70       12518.267     0.4996499
## 8         16169.79        39376.17       10872.205     2.2967967
## 9         15881.77        44684.82       11068.571     3.0544344
## 10        15128.73        59549.95       11531.425     3.7033388
## 11        17424.57        45399.44       11655.295     2.9618461
## 12        16900.52        69936.55       12995.556     3.6539245
## 13        31914.12        67167.57       19778.705     1.5789138
## 14        15235.99        54954.37       11260.253     4.2617162
## 15        13213.55        54776.69       10311.104     3.7298033
## 16        14905.10        39754.05       10497.167     3.1404521
## 17        21353.73        37767.69       11745.797     1.6670921
## 18        26151.28        27388.76       12757.993     0.9787133
## 19        12284.16        46006.08        9487.506     4.0727844
## 20        12948.84        75752.38       10354.672     4.1111447
## 21        16705.29        54605.80       12102.369     3.6810132
## 22        17774.68        50538.25       11555.432     2.7790231
## 23        28723.93        54276.86       16508.503     1.8237017
## 24        30772.67        41826.38       15187.158     1.3631666
## 25        20477.66        53777.02       13938.325     2.3071126
## 26        24444.36        47605.31       15109.019     1.5711915
## 27        12078.70        32515.38        8513.878     3.0264517
## 28        34038.20        45160.13       17460.120     1.2664590
## 29        47181.80        50581.81       19630.383     1.0739240
## 30        34831.90        33342.60       16309.533     0.8155681
## 31        16512.41        50143.11       12042.396     2.8206466
## 32        28937.74        48634.47       16995.899     1.8806864
## 33        39122.34        52684.32       20274.893     1.1892395
## 34        38893.95        47184.43       19110.939     1.1450987
## 35        47141.29        14440.81       10732.461     0.3008026
## 36        20367.69        52198.61       13715.333     2.3101455
## 37        16669.84        58239.17       11981.986     2.9607205
## 38        12619.41        44334.33        9173.024     3.3372943
##    Efisiensi_com
## 1      0.6572801
## 2      0.6354472
## 3      0.6594256
## 4      0.7645966
## 5      0.6835724
## 6      0.6654014
## 7      0.3082488
## 8      0.6542655
## 9      0.7053363
## 10     0.7452735
## 11     0.6821602
## 12     0.7403879
## 13     0.5438451
## 14     0.7571831
## 15     0.7601189
## 16     0.7325167
## 17     0.5281719
## 18     0.4682577
## 19     0.7845849
## 20     0.7362536
## 21     0.7396231
## 22     0.6436459
## 23     0.5494988
## 24     0.4799757
## 25     0.6465416
## 26     0.5616466
## 27     0.7272613
## 28     0.4858955
## 29     0.3939002
## 30     0.4271210
## 31     0.7114919
## 32     0.5958101
## 33     0.4776545
## 34     0.4581372
## 35     0.2245435
## 36     0.6460270
## 37     0.6751251
## 38     0.7142414

Rata-rata efisiensi:

rt_syn_3_0.1 <- mean(res_srs2_0.1$Efisiensi_syn)
rt_com_3_0.1 <- mean(res_srs2_0.1$Efisiensi_com)
rt_syn_3_0.1
## [1] 2.466905
rt_com_3_0.1
## [1] 0.6150123
      k. f = 5%
res_srs2_0.05
##    kab   Y dir   Y syn   Y com      MSE dir      MSE syn      MSE com
## 1    1 1605266 1444798 1546212  58544128587 155320152067  35187242148
## 2   10 2462822 2632037 2490834  94631985375 157781571895  51632927128
## 3   11 1424771 1701439 1450852  67132805488 155878633148  35464531051
## 4   12 1613137 2033371 1691499  52966402143 156185489238  34943472061
## 5   13 1672546 1428623 1577170  73328298941 156444269967  39431921763
## 6   14 2612636 2595422 2591623  82475762200 157328663341  48288950902
## 7   15 5084982 4827410 4860831 426028285126 157584627193 102718684974
## 8   16 2631731 2558517 2587759  80173336652 156162485540  47573845325
## 9   17 1970492 2248021 2020876  62040838795 156524765999  39609271040
## 10  18 1741692 1685909 1703904  61122287360 156193176464  38987972014
## 11  19 1823223 2224414 1902686  56995747177 155885924175  37039367985
## 12   2 1592739 1437274 1532901  62124812253 155900535219  38921461770
## 13  20 1895380 1499794 1694789 127264054064 155629535134  56966473376
## 14  21 1575244 1834821 1613251  62539789837 156109148464  37338614399
## 15  22 2007998 1827237 1946563  56645253446 156797259077  38461795618
## 16  23 2091849 2526882 2195769  64875716342 156516672910  41400518153
## 17  24 2739948 2667196 2671586 156446147603 156500515724  59256726336
## 18  25 3832270 3685580 3720011 204316258330 156420309594  80496818586
## 19  26 2014974 2223904 2057434  51282434558 155820652813  36249890380
## 20  27 1800823 1353262 1686141  54829146153 155907855236  34116181544
## 21  28 1578328 1875851 1634885  60763680394 155900535219  38239810799
## 22  29 1970406 2052446 1984768  89633369826 156508589485  45640396891
## 23   3 1739149 1861027 1721756 103966156668 155885924175  47568345125
## 24   4 2276095 2413918 2265814 150987701858 156216296123  57267475237
## 25   5 2058514 1871575 1961324  83874427015 156428286722  45892587062
## 26   6 2492470 2095351 2287724 131097356477 157391944045  62399150041
## 27   7 2693570 3037439 2795978  76188196052 158550391135  47288817153
## 28  71 2239970 2266304 2193469 188289808885 154707068007  68200034071
## 29  72 1850260 2032304 1853674 207324621400 154221888565  62880217295
## 30  73 3437453 3062068 3175279 261062860658 155706547514  89154744177
## 31  74 2225857 2041748 2141631  82092286992 154646956895  49273764136
## 32  75 1787210 2111090 1854849 111059477662 154325209522  54030232559
## 33  76 2104429 1949337 1971738 182747167146 154244959907  66706871558
## 34  77 2184151 2179412 2105502 219245561388 154306076011  72006025769
## 35  78 7003672 6950964 6955837 713049902144 158367753080 124405649465
## 36  79 2079220 1963674 2002274  99833494950 154408251856  50850449784
## 37   8 1954082 1726467 1854891  77807965279 156200873353  44737624228
## 38   9 2275690 2218162 2241990  64497901700 159095599550  40094034411
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         34127.81       108157.47        22442.99     2.6530441
## 2         36404.00        59900.78        20224.12     1.6673176
## 3         40505.52        91576.98        22974.37     2.3219443
## 4         30681.84        76537.20        19913.03     2.9487653
## 5         39345.16       110726.08        23988.35     2.1334774
## 6         30486.48        60584.27        18410.32     1.9075745
## 7         79033.91        32625.55        20894.70     0.3698924
## 8         29341.92        60898.49        18212.80     1.9478107
## 9         29786.90        69589.69        19105.59     2.5229312
## 10        32618.79        92788.93        22036.53     2.5554210
## 11        29430.29        69827.39        18809.07     2.7350448
## 12        36957.39       109091.31        24829.93     2.5094729
## 13        58813.39       103910.88        32366.28     1.2228868
## 14        36289.49        84984.91        22031.76     2.4961572
## 15        27114.35        86441.45        19344.57     2.7680564
## 16        29957.10        61814.22        18430.17     2.4125618
## 17        50393.47        59243.27        21556.49     1.0003475
## 18        51357.26        42452.04        21435.75     0.7655794
## 19        24781.73        70214.37        17348.15     3.0384800
## 20        28133.52       117369.09        19734.85     2.8435215
## 21        35790.52        83097.09        22349.45     2.5656862
## 22        41056.78        77029.99        21681.34     1.7460973
## 23        51480.52        83571.75        26244.14     1.4993910
## 24        57062.46        64509.74        24380.89     1.0346293
## 25        37690.59        83559.18        22841.79     1.8650296
## 26        49739.73        75154.48        26769.92     1.2005730
## 27        27509.22        52612.76        16728.23     2.0810362
## 28        75482.23        68046.80        30147.96     0.8216433
## 29        91661.67        75729.86        32387.83     0.7438667
## 30        71546.48        50595.02        27602.37     0.5964332
## 31        35700.41        75536.43        22735.17     1.8838184
## 32        56392.73        72923.67        28034.47     1.3895726
## 33        75696.99        79011.95        32835.90     0.8440348
## 34        84396.32        70589.72        32832.12     0.7038048
## 35        99523.17        22795.71        17823.60     0.2220991
## 36        44541.03        78495.37        24760.40     1.5466578
## 37        36969.47        90641.02        23366.26     2.0075178
## 38        27382.84        72405.19        17582.53     2.4666787
##    Efisiensi_com
## 1      0.6010379
## 2      0.5456181
## 3      0.5282742
## 4      0.6597290
## 5      0.5377449
## 6      0.5854926
## 7      0.2411077
## 8      0.5933874
## 9      0.6384387
## 10     0.6378683
## 11     0.6498620
## 12     0.6265043
## 13     0.4476242
## 14     0.5970377
## 15     0.6789941
## 16     0.6381512
## 17     0.3787676
## 18     0.3939815
## 19     0.7068676
## 20     0.6222271
## 21     0.6293202
## 22     0.5091898
## 23     0.4575368
## 24     0.3792857
## 25     0.5471583
## 26     0.4759757
## 27     0.6206843
## 28     0.3622078
## 29     0.3032935
## 30     0.3415068
## 31     0.6002240
## 32     0.4864982
## 33     0.3650227
## 34     0.3284264
## 35     0.1744698
## 36     0.5093526
## 37     0.5749749
## 38     0.6216332

Rata-rata efisiensi:

rt_syn_3_0.05 <- mean(res_srs2_0.05$Efisiensi_syn)
rt_com_3_0.05 <- mean(res_srs2_0.05$Efisiensi_com)
rt_syn_3_0.05
## [1] 1.790496
rt_com_3_0.05
## [1] 0.5156704
  2. Metode One stage cluster 
      a. f = 100%
res_1sc2_1
##    kab   Y dir   Y syn   Y com MSE dir     MSE syn MSE com Relatif MSE dir
## 1    1 1637409 1484546 1637409       0 53757885490       0               0
## 2   10 2452226 2656398 2452226       0 47147642278       0               0
## 3   11 1432925 1736676 1432925       0 52258061800       0               0
## 4   12 1628141 2070386 1628141       0 51433987269       0               0
## 5   13 1660654 1452773 1660654       0 50739021079       0               0
## 6   14 2677707 2617885 2677707       0 48363946648       0               0
## 7   15 5059790 4863519 5059790       0 47676545298       0               0
## 8   16 2702258 2596479 2702258       0 51495764637       0               0
## 9   17 2063216 2280593 2063216       0 50522845707       0               0
## 10  18 1802921 1720645 1802921       0 51413342911       0               0
## 11  19 1893080 2266122 1893080       0 52238481449       0               0
## 12   2 1631372 1473225 1631372       0 52199242895       0               0
## 13  20 1933963 1539654 1933963       0 52927024662       0               0
## 14  21 1543883 1871616 1543883       0 51639003528       0               0
## 15  22 2024290 1859814 2024290       0 49791054445       0               0
## 16  23 2145480 2562473 2145480       0 50544580026       0               0
## 17  24 2721467 2698896 2721467       0 50587970809       0               0
## 18  25 3923463 3722909 3923463       0 50803367638       0               0
## 19  26 2049321 2256961 2049321       0 52413770351       0               0
## 20  27 1850200 1379119 1850200       0 52179584690       0               0
## 21  28 1632444 1899669 1632444       0 52199242895       0               0
## 22  29 1945828 2049705 1945828       0 50566288393       0               0
## 23   3 1794553 1899490 1794553       0 52238481449       0               0
## 24   4 2297582 2449242 2297582       0 51351254126       0               0
## 25   5 2083579 1902456 2083579       0 50781944736       0               0
## 26   6 2526531 2124414 2526531       0 48194003740       0               0
## 27   7 2716794 3050885 2716794       0 45082946891       0               0
## 28  71 2297609 2314435 2297609       0 55404347708       0               0
## 29  72 1872873 2081921 1872873       0 56707316863       0               0
## 30  73 3484448 3097221 3484448       0 52720204779       0               0
## 31  74 2197198 2088987 2197198       0 55565778548       0               0
## 32  75 1867766 2160606 1867766       0 56429844225       0               0
## 33  76 2088732 1998934 2088732       0 56645357835       0               0
## 34  77 2275392 2228054 2275392       0 56481228047       0               0
## 35  78 7020112 6960868 7020112       0 45573428827       0               0
## 36  79 2178314 2012520 2178314       0 56206830653       0               0
## 37   8 2025630 1758243 2025630       0 51392672600       0               0
## 38   9 2279804 2230617 2279804       0 43618767484       0               0
##    Relatif MSE syn Relatif MSE com Efisiensi_syn Efisiensi_com
## 1         36211.67               0           Inf           NaN
## 2         17748.71               0           Inf           NaN
## 3         30090.85               0           Inf           NaN
## 4         24842.70               0           Inf           NaN
## 5         34925.63               0           Inf           NaN
## 6         18474.43               0           Inf           NaN
## 7          9802.89               0           Inf           NaN
## 8         19832.92               0           Inf           NaN
## 9         22153.38               0           Inf           NaN
## 10        29880.28               0           Inf           NaN
## 11        23051.93               0           Inf           NaN
## 12        35431.95               0           Inf           NaN
## 13        34375.92               0           Inf           NaN
## 14        27590.60               0           Inf           NaN
## 15        26772.07               0           Inf           NaN
## 16        19724.92               0           Inf           NaN
## 17        18743.95               0           Inf           NaN
## 18        13646.15               0           Inf           NaN
## 19        23223.17               0           Inf           NaN
## 20        37835.45               0           Inf           NaN
## 21        27478.07               0           Inf           NaN
## 22        24670.03               0           Inf           NaN
## 23        27501.31               0           Inf           NaN
## 24        20966.18               0           Inf           NaN
## 25        26692.84               0           Inf           NaN
## 26        22685.79               0           Inf           NaN
## 27        14777.01               0           Inf           NaN
## 28        23938.60               0           Inf           NaN
## 29        27237.97               0           Inf           NaN
## 30        17021.78               0           Inf           NaN
## 31        26599.39               0           Inf           NaN
## 32        26117.60               0           Inf           NaN
## 33        28337.79               0           Inf           NaN
## 34        25350.03               0           Inf           NaN
## 35         6547.09               0           Inf           NaN
## 36        27928.58               0           Inf           NaN
## 37        29229.57               0           Inf           NaN
## 38        19554.58               0           Inf           NaN

Rata-rata efisiensi:

rt_syn_4_1 <- mean(res_1sc2_1$Efisiensi_syn)
rt_com_4_1 <- mean(res_1sc2_1$Efisiensi_com)
rt_syn_4_1
## [1] Inf
rt_com_4_1
## [1] NaN
      b. f = 90%
res_1sc2_0.9
##    kab   Y dir   Y syn   Y com     MSE dir     MSE syn     MSE com
## 1    1 1630245 1476800 1627500   967558390 54211890757   950311909
## 2   10 2451728 2645514 2455333   905334100 47826371464   888315670
## 3   11 1427724 1726411 1432333   828155147 52763055547   815182973
## 4   12 1633745 2055681 1641365   953912648 51966996515   936519444
## 5   13 1647670 1445834 1645306   602279355 51295656616   595176950
## 6   14 2672073 2605765 2670306  1310790998 49001325967  1276341177
## 7   15 5047244 4837242 5015413  8365042828 48337293731  7114493447
## 8   16 2698089 2583709 2696219   853738513 52026673680   839839741
## 9   17 2046559 2270266 2050351   886135802 51086830410   870820621
## 10  18 1804629 1712994 1803569   601033201 51947053989   594101858
## 11  19 1880520 2252404 1885823   761998543 52744140857   751040990
## 12   2 1625254 1466822 1622626   882128747 52706236268   867489192
## 13  20 1907960 1530587 1899927  1155305219 53409276136  1130644426
## 14  21 1545187 1860751 1549733   763535367 52165042977   752383239
## 15  22 2021562 1852325 2018643   874676752 50379917355   859606636
## 16  23 2128727 2549428 2137959  1145093996 51107825842  1119773486
## 17  24 2693096 2687735 2692948  1144501812 51149741498  1119196151
## 18  25 3899411 3702676 3877112  6399992446 51357815628  5681484342
## 19  26 2035556 2238883 2040521  1327597596 52913470581  1294786128
## 20  27 1837456 1366614 1830061   837325480 52687246370   824132135
## 21  28 1620293 1883507 1626177  1207763233 52706236268  1180411864
## 22  29 1932028 2034917 1935103  1585722629 51128796205  1536575140
## 23   3 1780090 1887342 1782957  1487842337 52744140857  1446428484
## 24   4 2293830 2435606 2297596  1434998078 51887075994  1395868027
## 25   5 2066918 1892869 2063449  1032472440 51337121027  1011893489
## 26   6 2506349 2115166 2493136  1680635216 48837160492  1623505355
## 27   7 2710464 3044015 2718221  1085552196 45831868116  1060132686
## 28  71 2297885 2297114 2297741  2149882186 55802379324  2069068798
## 29  72 1860215 2065059 1867136  2046520226 57061052327  1973977262
## 30  73 3471490 3075500 3441968  4263288906 53209487368  3945086316
## 31  74 2179834 2072384 2178355   775303856 55958322111   764616093
## 32  75 1837016 2143781 1846526  1840192276 56793012737  1780636351
## 33  76 2077261 1982692 2074985  1377032941 57001199678  1344254907
## 34  77 2239860 2210460 2238191  2964797107 56842649698  2815757233
## 35  78 6962747 6913278 6947911 18591946422 46305675473 13202833835
## 36  79 2136666 1996717 2134359   938536049 56577580805   923077647
## 37   8 2025481 1750504 2021024   848303426 51927086393   834545440
## 38   9 2262540 2226052 2261280  1412869912 44417465415  1368008788
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         592.8180       36716.495        583.2604     56.029581
## 2         369.1794       18076.821        361.7093     52.827317
## 3         579.5465       30563.817        568.6381     63.711559
## 4         583.5449       25280.007        570.2493     54.477731
## 5         365.3001       35487.023        361.5194     85.169210
## 6         490.4941       18804.414        477.9233     37.383020
## 7        1654.8052        9991.448       1416.8101      5.778487
## 8         316.3809       20134.961        311.4479     60.939823
## 9         432.6223       22501.718        424.3643     57.651243
## 10        332.9503       30327.003        329.3066     86.429591
## 11        405.0057       23416.295        398.0608     69.218165
## 12        542.5369       35937.955        534.4044     59.748916
## 13        605.2005       34898.491        594.8010     46.229581
## 14        493.7047       28036.266        485.0714     68.320402
## 15        432.5348       27201.468        425.7036     57.598327
## 16        537.7700       20045.603        523.6121     44.631992
## 17        424.8307       19032.357        415.4666     44.691709
## 18       1638.8293       13869.346       1463.5612      8.024668
## 19        651.8279       23636.820        634.1806     39.856558
## 20        455.4352       38567.438        450.0800     62.923257
## 21        744.9316       27987.896        725.4468     43.639544
## 22        818.8873       25141.340        792.2850     32.243215
## 23        834.7718       27946.791        810.2713     35.450087
## 24        624.9891       21302.921        606.9688     36.158290
## 25        499.1212       27121.860        490.0103     49.722510
## 26        669.4820       23089.843        650.2465     29.058751
## 27        400.4071       15054.982        389.9132     42.219866
## 28        934.4853       24291.609        899.4761     25.956017
## 29       1097.6514       27631.744       1054.9240     27.881988
## 30       1227.5031       17301.108       1145.6856     12.480854
## 31        355.6530       27002.126        350.9894     72.175988
## 32        999.7080       26491.687        962.3536     30.862543
## 33        662.5509       28749.926        647.5061     41.394216
## 34       1321.5299       25714.955       1256.1884     19.172526
## 35       2665.6955        6698.905       1898.0318      2.490631
## 36        438.9071       28335.742        432.1540     60.282800
## 37        418.5637       29666.115        412.6924     61.212869
## 38        623.3980       19952.737        603.9832     31.437760
##    Efisiensi_com
## 1      0.9821753
## 2      0.9812020
## 3      0.9843361
## 4      0.9817665
## 5      0.9882075
## 6      0.9737183
## 7      0.8505029
## 8      0.9837201
## 9      0.9827169
## 10     0.9884676
## 11     0.9856200
## 12     0.9834043
## 13     0.9786543
## 14     0.9853941
## 15     0.9827706
## 16     0.9778878
## 17     0.9778894
## 18     0.8877330
## 19     0.9752851
## 20     0.9842435
## 21     0.9773537
## 22     0.9690063
## 23     0.9721652
## 24     0.9727316
## 25     0.9800683
## 26     0.9660070
## 27     0.9765838
## 28     0.9624103
## 29     0.9645530
## 30     0.9253622
## 31     0.9862147
## 32     0.9676360
## 33     0.9761966
## 34     0.9497302
## 35     0.7101373
## 36     0.9835292
## 37     0.9837818
## 38     0.9682482

Rata-rata efisiensi:

rt_syn_4_0.9 <- mean(res_1sc2_0.9$Efisiensi_syn)
rt_com_4_0.9 <- mean(res_1sc2_0.9$Efisiensi_com)
rt_syn_4_0.9
## [1] 45.14425
rt_com_4_0.9
## [1] 0.9633529
      c. f = 80%
res_1sc2_0.8
##    kab   Y dir   Y syn   Y com     MSE dir     MSE syn     MSE com
## 1    1 1624312 1471983 1618351  2199618313 55650683914  2113303149
## 2   10 2457058 2647065 2464544  2028526604 49168770950  1946533492
## 3   11 1405915 1722378 1416021  1809129511 54179977571  1748837690
## 4   12 1625649 2048575 1641989  2148033993 53371901497  2063209326
## 5   13 1663682 1446157 1657925  1402146507 52690427274  1364616952
## 6   14 2648726 2610265 2646503  2875560607 50361462174  2718254695
## 7   15 5067949 4846004 5002602 19337153056 49687405929 13806015389
## 8   16 2695027 2584974 2691153  1925149448 53432479529  1857507074
## 9   17 2053979 2271344 2061648  1948816235 52478448698  1876999193
## 10  18 1805098 1710402 1802679  1363874990 53351657925  1329298653
## 11  19 1870100 2247957 1881650  1709564199 54160777351  1656113883
## 12   2 1614713 1462698 1609203  1989578074 54122300567  1917783334
## 13  20 1920657 1524355 1902604  2592773911 54835953291  2474229051
## 14  21 1542085 1855075 1551712  1702658832 53572937602  1649143209
## 15  22 2023139 1854560 2016886  1937416554 51760864319  1865840051
## 16  23 2135366 2551040 2154822  2579077629 52499761070  2456056909
## 17  24 2714173 2701232 2713422  2616127325 52542309471  2490194910
## 18  25 3901898 3711873 3860037 14077719994 52753524619 11047195878
## 19  26 2024313 2232910 2035041  2983561101 54332663220  2824867177
## 20  27 1827896 1361733 1812019  1897236946 54103024004  1832132279
## 21  28 1603463 1877174 1616149  2651155935 54122300567  2524883280
## 22  29 1944249 2031043 1949710  3625216768 52521047994  3379233146
## 23   3 1769095 1880219 1775420  3365118156 54160777351  3164344833
## 24   4 2298987 2432988 2306337  3240001926 53290774522  3049625716
## 25   5 2075718 1888985 2067615  2332452614 52732517618  2231641041
## 26   6 2495695 2111690 2467755  3836790637 50194818512  3554934331
## 27   7 2716348 3057822 2733469  2461214769 47144159244  2335680595
## 28  71 2299056 2288740 2297863  4888146413 57265181967  4493728493
## 29  72 1847757 2054437 1862373  4622309488 58542855478  4271617350
## 30  73 3420435 3067250 3368154  9351140694 54633148577  7966530622
## 31  74 2159206 2062445 2156318  1743723932 57423478814  1691658081
## 32  75 1842447 2134223 1860327  4021511489 58270769652  3740309248
## 33  76 2064658 1971926 2059870  3051573568 58482099314  2897338516
## 34  77 2226812 2200171 2222894  6503347937 58321155916  5826602409
## 35  78 6965679 6908238 6937840 41447865320 47625119039 21929620245
## 36  79 2153013 1986514 2146885  2164382683 58052085631  2085047753
## 37   8 2018219 1748766 2008890  1879192901 53331388905  1814089716
## 38   9 2273591 2230957 2270277  3250183872 45708405191  3021044307
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1        1350.9484       37828.684       1302.9709     25.300155
## 2         825.0495       18574.568        789.3271     24.238662
## 3        1282.5568       31458.493       1230.9911     29.948092
## 4        1319.1956       26054.684       1254.5624     24.846861
## 5         841.7022       36452.968        822.1070     37.578404
## 6        1085.1662       19292.427       1026.7119     17.513615
## 7        3804.0089       10254.023       2754.6067      2.569531
## 8         714.1624       20669.361        690.0681     27.754977
## 9         946.9244       23102.700        908.6839     26.928372
## 10        755.0746       31194.266        736.9481     39.117704
## 11        913.0406       24091.962        879.0863     31.681043
## 12       1231.2052       37010.100       1190.9322     27.202904
## 13       1348.2365       35981.352       1298.9667     21.149531
## 14       1102.6825       28878.892       1061.4164     31.464282
## 15        956.3148       27910.513        923.9451     26.716435
## 16       1206.9191       20578.649       1139.0105     20.356022
## 17        963.0585       19455.653        917.0207     20.084003
## 18       3594.5893       14212.659       2854.7055      3.747306
## 19       1472.0844       24335.317       1386.5363     18.210676
## 20       1036.5991       39758.066       1009.8957     28.516746
## 21       1650.8250       28836.289       1559.9864     20.414605
## 22       1855.5713       25877.762       1725.1700     14.487699
## 23       1898.8699       28808.304       1779.4485     16.094762
## 24       1405.8835       21901.520       1319.3104     16.447760
## 25       1121.4501       27917.581       1077.3639     22.608184
## 26       1532.7818       23769.312       1436.9777     13.082501
## 27        905.5324       15422.921        853.9369     19.154834
## 28       2121.3980       25023.073       1951.7355     11.715112
## 29       2492.0100       28499.860       2285.5850     12.665283
## 30       2730.5765       17812.249       2363.1475      5.842405
## 31        807.4201       27846.539        784.3723     32.931520
## 32       2165.1767       27306.581       1994.6446     14.489768
## 33       1476.4304       29662.789       1405.2250     19.164571
## 34       2905.6577       26510.195       2609.8305      8.967866
## 35       5929.7051        6895.327       3155.0645      1.149037
## 36       1003.9985       29228.435        970.0582     26.821544
## 37        929.6190       30504.766        901.6964     28.379944
## 38       1425.1661       20489.412       1326.9973     14.063329
##    Efisiensi_com
## 1      0.9607590
## 2      0.9595800
## 3      0.9666736
## 4      0.9605106
## 5      0.9732342
## 6      0.9452956
## 7      0.7139632
## 8      0.9648638
## 9      0.9631484
## 10     0.9746485
## 11     0.9687345
## 12     0.9639146
## 13     0.9542788
## 14     0.9685694
## 15     0.9630557
## 16     0.9523005
## 17     0.9518630
## 18     0.7847291
## 19     0.9468106
## 20     0.9656845
## 21     0.9523707
## 22     0.9321465
## 23     0.9403369
## 24     0.9412419
## 25     0.9567787
## 26     0.9265385
## 27     0.9489950
## 28     0.9193114
## 29     0.9241305
## 30     0.8519314
## 31     0.9701410
## 32     0.9300755
## 33     0.9494572
## 34     0.8959389
## 35     0.5290893
## 36     0.9633452
## 37     0.9653558
## 38     0.9294995

Rata-rata efisiensi:

rt_syn_4_0.8 <- mean(res_1sc2_0.8$Efisiensi_syn)
rt_com_4_0.8 <- mean(res_1sc2_0.8$Efisiensi_com)
rt_syn_4_0.8
## [1] 20.61595
rt_com_4_0.8
## [1] 0.9270869
      d. f = 70%
res_1sc2_0.7
##    kab   Y dir   Y syn   Y com     MSE dir     MSE syn     MSE com
## 1    1 1608711 1463532 1599641  3690096960 58828513336  3460547034
## 2   10 2450337 2649899 2462722  3477714264 52534126479  3256862653
## 3   11 1432558 1721980 1447580  3209780927 57400355517  3031318040
## 4   12 1626934 2055869 1653455  3727702471 56615657629  3491220038
## 5   13 1640088 1432961 1631859  2210318047 55953898914  2119883473
## 6   14 2668889 2600771 2662811  4945616664 53692312342  4517778088
## 7   15 5064430 4849225 4978375 32496861579 53037756998 19826118977
## 8   16 2700804 2579763 2693771  3353980651 56674483097  3162349986
## 9   17 2032761 2269457 2045861  3363538079 55748053020  3162297334
## 10  18 1806416 1709638 1802458  2332476531 56595999716  2238113824
## 11  19 1878253 2252140 1896134  2896188724 57381710772  2753071763
## 12   2 1621438 1463028 1612313  3383067725 57344347148  3189970389
## 13  20 1913479 1524305 1885607  4407461349 58037353418  4089648368
## 14  21 1543510 1863154 1559182  2937664918 56810877623  2788427483
## 15  22 2013851 1848265 2004094  3310458572 55051228841  3116560002
## 16  23 2114018 2545112 2145241  4354152893 55768748811  4031204994
## 17  24 2692934 2666956 2690783  4493523535 55810066258  4151768613
## 18  25 3865489 3694441 3809684 24652924062 56015170809 16894421111
## 19  26 2032692 2247432 2049676  5064943072 57548623868  4642168374
## 20  27 1831015 1359598 1806028  3170759496 57325628269  2999913491
## 21  28 1625079 1881247 1644330  4722316526 57344347148  4351731272
## 22  29 1914496 2022606 1924595  6025391854 55789419890  5392197227
## 23   3 1791077 1886750 1798990  5809511623 57381710772  5251911040
## 24   4 2302177 2438997 2313382  5512128452 56536877712  4998685067
## 25   5 2049643 1894098 2039039  3874343926 55994771556  3612861108
## 26   6 2516436 2123840 2471525  6593250830 53530489793  5829689987
## 27   7 2701237 3036508 2726723  4111938267 50568088152  3786937807
## 28  71 2306484 2292105 2302924  8316009013 60396302873  7256621067
## 29  72 1828805 2060546 1853398  7800816132 61637012429  6858789482
## 30  73 3472311 3082352 3384103 16681083601 57840415981 12898925837
## 31  74 2184094 2067007 2178535  2965890717 60550020085  2824984876
## 32  75 1843636 2138204 1871111  6851820027 61372798229  6079987782
## 33  76 2043596 1977117 2037996  5179311732 61578013981  4766985430
## 34  77 2237998 2207137 2230662 11524465598 61421726784  9625041426
## 35  78 7040191 6982970 7004335 74252788939 51035133456 29757318646
## 36  79 2158084 1990844 2148335  3662156088 61160440884  3449863369
## 37   8 2029845 1740709 2013613  3297366826 56576317093  3111739180
## 38   9 2270484 2233717 2265676  5337589633 49173871430  4752599980
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         2284.238       40225.251        2155.541     15.942268
## 2         1417.578       19824.823        1320.982     15.105935
## 3         2230.659       33337.137        2085.021     17.882951
## 4         2287.621       27544.533        2108.280     15.187816
## 5         1341.941       39072.102        1294.163     25.314863
## 6         1851.456       20641.144        1695.347     10.856546
## 7         6386.966       10940.365        3973.707      1.632089
## 8         1241.111       21967.409        1173.351     16.897677
## 9         1648.393       24561.368        1540.110     16.574230
## 10        1289.988       33103.430        1240.607     24.264338
## 11        1538.911       25478.242        1449.252     19.812835
## 12        2082.668       39202.637        1975.309     16.950399
## 13        2298.028       38084.848        2164.629     13.167978
## 14        1898.866       30493.431        1784.379     19.338788
## 15        1640.110       29781.859        1551.949     16.629487
## 16        2057.658       21910.521        1877.460     12.808174
## 17        1666.419       20933.995        1541.130     12.420112
## 18        6344.631       15164.158        4420.795      2.272151
## 19        2486.535       25617.142        2260.564     11.362146
## 20        1725.993       42216.209        1656.275     18.079463
## 21        2900.042       30491.339        2641.903     12.143266
## 22        3120.506       27611.865        2779.794      9.259053
## 23        3226.425       30418.893        2905.797      9.877200
## 24        2384.431       23179.142        2152.835     10.256814
## 25        1884.441       29565.566        1767.163     14.452711
## 26        2607.751       25206.711        2350.783      8.118983
## 27        1519.287       16658.126        1386.079     12.297871
## 28        3582.714       26356.734        3134.806      7.262655
## 29        4232.508       29922.072        3674.268      7.901354
## 30        4797.415       18767.596        3807.923      3.467426
## 31        1357.166       29302.625        1296.067     20.415459
## 32        3672.000       28711.227        3211.836      8.957153
## 33        2529.480       31156.537        2335.200     11.889227
## 34        5114.732       27834.993        4292.748      5.329681
## 35       10501.046        7315.234        4242.619      0.687316
## 36        1692.799       30731.453        1602.339     16.700665
## 37        1621.720       32508.564        1543.097     17.158029
## 38        2335.087       22014.790        2085.348      9.212749
##    Efisiensi_com
## 1      0.9377930
## 2      0.9364952
## 3      0.9444003
## 4      0.9365608
## 5      0.9590853
## 6      0.9134914
## 7      0.6100933
## 8      0.9428647
## 9      0.9401699
## 10     0.9595440
## 11     0.9505844
## 12     0.9429224
## 13     0.9278921
## 14     0.9491986
## 15     0.9414285
## 16     0.9258299
## 17     0.9239450
## 18     0.6852908
## 19     0.9165292
## 20     0.9461183
## 21     0.9215247
## 22     0.8949123
## 23     0.9040194
## 24     0.9068521
## 25     0.9325091
## 26     0.8841905
## 27     0.9209617
## 28     0.8726086
## 29     0.8792400
## 30     0.7732667
## 31     0.9524912
## 32     0.8873537
## 33     0.9203897
## 34     0.8351833
## 35     0.4007569
## 36     0.9420307
## 37     0.9437043
## 38     0.8904019

Rata-rata efisiensi:

rt_syn_4_0.7 <- mean(res_1sc2_0.7$Efisiensi_syn)
rt_com_4_0.7 <- mean(res_1sc2_0.7$Efisiensi_com)
rt_syn_4_0.7
## [1] 12.83915
rt_com_4_0.7
## [1] 0.8908588
      e. f = 60%
res_1sc2_0.6
##    kab   Y dir   Y syn   Y com      MSE dir     MSE syn     MSE com
## 1    1 1596830 1462873 1584290   5748600406 61666744264  5216080710
## 2   10 2453780 2640554 2470352   5451677413 56106576433  4950684590
## 3   11 1408747 1717212 1430836   4832188810 60405176245  4440182765
## 4   12 1633631 2045035 1670090   5840302635 59712010722  5296039460
## 5   13 1649960 1435372 1637231   3578287628 59127443932  3355862022
## 6   14 2656859 2600141 2649132   7662383884 57129663816  6718094778
## 7   15 5035380 4836678 4936716  49293215685 56551460148 25760155054
## 8   16 2697008 2576717 2687004   5097493129 59763974397  4684159976
## 9   17 2042885 2265307 2060432   5199922738 58945609269  4756409407
## 10  18 1801417 1705616 1795562   3596638272 59694645839  3383022110
## 11  19 1872032 2244309 1898408   4652618008 60388706347  4307491697
## 12   2 1616706 1459029 1603453   5200698779 60355701063  4768989257
## 13  20 1932066 1519577 1888647   7026459885 60967870486  6280703175
## 14  21 1542516 1853667 1564305   4573931601 59884458962  4232154820
## 15  22 1991569 1849494 1979535   5159586400 58330067283  4723308691
## 16  23 2126017 2542705 2169568   6884341903 58963890965  6140185930
## 17  24 2704546 2683070 2701957   6710087537 59000388871  6000501281
## 18  25 3901931 3697155 3815856  37678785198 59181568668 22484488578
## 19  26 2013663 2233760 2037622   7708170832 60536149592  6787676169
## 20  27 1820780 1355804 1785159   4909417839 60339165678  4522126278
## 21  28 1610098 1873247 1637216   7174828041 60355701063  6375652485
## 22  29 1921270 2021782 1934294   9056570963 58982150833  7695123372
## 23   3 1760780 1876649 1772767   8522545943 60388706347  7390806439
## 24   4 2287032 2429590 2303361   8623147940 59642420217  7479711676
## 25   5 2067625 1884952 2049021   6203672308 59163548918  5578057596
## 26   6 2492687 2110785 2433320  10050757640 56986717323  8434365828
## 27   7 2688002 3039258 2725210   6378923803 54369869855  5660859886
## 28  71 2295948 2282580 2290669  13421204601 63051656432 10913253693
## 29  72 1816565 2049967 1848952  12030466272 64147641398  9935213596
## 30  73 3425704 3064926 3318496  24670414636 60793905138 17406090188
## 31  74 2165353 2057246 2157626   4590980123 63187443050  4267865276
## 32  75 1831418 2128692 1869881  10585275364 63914246894  8859975752
## 33  76 2033239 1967128 2024703   7990667945 64095524920  7065085385
## 34  77 2239629 2195800 2225169  17124777211 63957468098 13275130390
## 35  78 6986886 6925236 6943981 112772563787 54782435897 36136727411
## 36  79 2161281 1981300 2146007   5593024783 63726660318  5117087293
## 37   8 2020501 1739305 1997688   5092042994 59677259127  4674941316
## 38   9 2275306 2225128 2265934   8541603621 53138283818  7191877425
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         3572.626       42234.882        3271.856     10.727262
## 2         2218.569       21249.541        2001.420     10.291617
## 3         3399.819       35194.076        3076.988     12.500583
## 4         3560.198       29212.666        3159.147     10.224130
## 5         2160.248       41282.325        2043.404     16.523949
## 6         2878.932       21969.836        2532.486      7.455860
## 7         9726.245       11690.716        5204.017      1.147246
## 8         1887.869       23191.960        1741.630     11.724189
## 9         2536.785       26017.436        2301.334     11.335863
## 10        1992.722       35009.467        1880.993     16.597345
## 11        2477.203       26903.952        2262.308     12.979511
## 12        3203.939       41394.508        2964.243     11.605306
## 13        3626.535       40156.073        3318.304      8.676897
## 14        2952.045       32308.760        2693.902     13.092557
## 15        2582.231       31536.061        2379.304     11.305183
## 16        3232.288       23187.502        2825.758      8.564928
## 17        2474.707       22007.190        2215.992      8.792790
## 18        9569.181       16008.440        5866.991      1.570687
## 19        3812.626       27111.711        3319.847      7.853504
## 20        2684.807       44643.022        2524.528     12.290493
## 21        4435.408       32247.771        3879.561      8.412146
## 22        4651.222       29252.614        3931.154      6.512636
## 23        4793.695       32197.958        4136.648      7.085759
## 24        3750.675       24543.170        3233.167      6.916548
## 25        2987.343       31403.558        2713.115      9.536859
## 26        4013.255       27000.997        3457.482      5.669893
## 27        2367.361       17906.505        2072.429      8.523361
## 28        5799.432       27638.678        4736.194      4.697913
## 29        6535.175       31312.697        5314.273      5.332099
## 30        7174.905       19835.424        5234.576      2.464243
## 31        2117.809       30736.148        1976.254     13.763389
## 32        5701.549       30044.044        4677.419      6.038033
## 33        3911.193       32609.233        3475.602      8.021298
## 34        7560.930       29141.792        5920.035      3.734791
## 35       16028.639        7907.884        5189.636      0.485778
## 36        2576.112       32189.520        2375.540     11.393953
## 37        2515.062       34349.197        2336.594     11.719708
## 38        3718.149       23891.740        3149.963      6.221113
##    Efisiensi_com
## 1      0.9073653
## 2      0.9081030
## 3      0.9188761
## 4      0.9068091
## 5      0.9378402
## 6      0.8767630
## 7      0.5225903
## 8      0.9189144
## 9      0.9147077
## 10     0.9406067
## 11     0.9258211
## 12     0.9169901
## 13     0.8938645
## 14     0.9252772
## 15     0.9154433
## 16     0.8919060
## 17     0.8942508
## 18     0.5967413
## 19     0.8805820
## 20     0.9211125
## 21     0.8886140
## 22     0.8496730
## 23     0.8672064
## 24     0.8673992
## 25     0.8991541
## 26     0.8391771
## 27     0.8874318
## 28     0.8131352
## 29     0.8258378
## 30     0.7055451
## 31     0.9296196
## 32     0.8370095
## 33     0.8841671
## 34     0.7752002
## 35     0.3204390
## 36     0.9149052
## 37     0.9180876
## 38     0.8419821

Rata-rata efisiensi:

rt_syn_4_0.6 <- mean(res_1sc2_0.6$Efisiensi_syn)
rt_com_4_0.6 <- mean(res_1sc2_0.6$Efisiensi_com)
rt_syn_4_0.6
## [1] 8.731301
rt_com_4_0.6
## [1] 0.8520829
      f. f = 50%
res_1sc2_0.5
##    kab   Y dir   Y syn   Y com      MSE dir     MSE syn     MSE com
## 1    1 1632835 1484396 1613201   9149275272 67311267052  7948070392
## 2   10 2442102 2658680 2466708   7982011652 60858805820  6992421633
## 3   11 1436098 1734481 1466663   7720659809 65847243127  6846585626
## 4   12 1622028 2069503 1671054   8223150817 65042838691  7221189479
## 5   13 1658700 1455429 1641716   5267253894 64364460868  4807581210
## 6   14 2680381 2616552 2668716  11553496906 62046077838  9662938225
## 7   15 5049364 4865599 4938295  75538502109 61375084288 32841791663
## 8   16 2704944 2594129 2692447   7696106400 65103141475  6847774518
## 9   17 2051418 2278097 2074119   7775100723 64153445455  6856226160
## 10  18 1789562 1717167 1783542   5336973548 65022687099  4910048163
## 11  19 1885847 2261112 1921024   6893154128 65828130146  6193962187
## 12   2 1630842 1468403 1612471   7834424327 65789828189  6949914399
## 13  20 1929203 1536348 1872919  10634835530 66500238303  9088597489
## 14  21 1541598 1866919 1572280   6992767358 65242961352  6258300391
## 15  22 2006537 1851819 1988688   7553923526 63439121549  6696909296
## 16  23 2139990 2559908 2197780  10297389336 64174660990  8783194497
## 17  24 2730352 2695276 2724411  10411215457 64217016065  8893352334
## 18  25 3931271 3721743 3824907  56823637116 64427271519 29219017843
## 19  26 2040098 2252817 2071120  12181761255 65999235021 10154976073
## 20  27 1851796 1380423 1803166   7406626495 65770639212  6613740995
## 21  28 1635279 1896860 1671101  11001886098 65789828189  9322529043
## 22  29 1930172 2041215 1947762  13383817835 64195851193 10696817390
## 23   3 1785951 1898597 1801648  13275318879 65828130146 10889033626
## 24   4 2289779 2445629 2311009  12587035083 64962080331 10381621248
## 25   5 2087316 1902848 2060778   9800476889 64406359967  8407974252
## 26   6 2531720 2122752 2442357  16310014002 61880191351 12614490978
## 27   7 2719634 3062810 2767909   9586691380 58843393300  8103835657
## 28  71 2304420 2313967 2299269  19363750966 68918429344 14690811281
## 29  72 1868184 2080171 1903761  18943411549 70190297517 14289160232
## 30  73 3496997 3093098 3345317  38993407097 66298355069 24224278103
## 31  74 2193982 2087575 2183312   7046233853 69076006941  6357070891
## 32  75 1857099 2159343 1907501  17023642203 69919447961 13052391409
## 33  76 2072897 1997407 2060241  11976143554 70129817409 10126699458
## 34  77 2302002 2226120 2273553  29039513066 69969605286 20063945356
## 35  78 7010166 6951603 6963500 171393204556 59322167767 42828876146
## 36  79 2176669 2011265 2156973   8745647098 69701757570  7716448412
## 37   8 2029909 1759446 1999560   7845808231 65002510175  6949846857
## 38   9 2308347 2235983 2289253  14377199825 57414162852 11045050025
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         5545.196       45496.965        4887.056     7.3570053
## 2         3255.867       22890.558        2825.438     7.6244947
## 3         5335.778       37982.787        4635.937     8.5287067
## 4         5023.250       31433.200        4286.790     7.9097222
## 5         3141.983       44366.504        2904.133    12.2197377
## 6         4302.623       23697.262        3615.997     5.3703289
## 7        14824.919       12594.038        6626.661     0.8125007
## 8         2843.400       25079.906        2542.015     8.4592310
## 9         3760.162       28146.311        3282.850     8.2511401
## 10        2975.198       37894.851        2747.360    12.1834381
## 11        3637.933       29095.275        3209.919     9.5497836
## 12        4784.870       44880.111        4297.130     8.3975319
## 13        5482.503       43349.612        4834.136     6.2530575
## 14        4499.833       34950.837        3951.487     9.3300632
## 15        3739.404       34241.313        3349.138     8.3981684
## 16        4793.961       25050.016        3983.178     6.2321292
## 17        3800.182       23822.199        3255.099     6.1680614
## 18       14282.295       17290.164        7597.206     1.1338111
## 19        5932.033       29278.721        4876.796     5.4178730
## 20        3972.433       47774.209        3648.475     8.8799724
## 21        6681.356       34690.752        5547.726     5.9798681
## 22        6812.275       31551.892        5410.770     4.7965276
## 23        7362.256       34695.560        6001.455     4.9586854
## 24        5447.706       26543.630        4462.155     5.1610312
## 25        4662.435       33877.596        4059.482     6.5717578
## 26        6403.429       29166.932        5150.599     3.7939999
## 27        3509.611       19236.888        2917.409     6.1380294
## 28        8273.735       29788.095        6321.426     3.5591466
## 29        9916.151       33755.064        7373.495     3.7052617
## 30       11101.486       21424.221        7220.627     1.7002452
## 31        3203.388       33103.491        2905.836     9.8032521
## 32        8981.224       32390.182        6720.418     4.1071968
## 33        5747.393       35132.152        4895.933     5.8557930
## 34       12485.621       31435.562        8769.958     2.4094621
## 35       24160.139        8521.921        6123.326     0.3461174
## 36        3995.768       34678.523        3561.714     7.9698800
## 37        3847.904       37018.154        3464.184     8.2849986
## 38        6135.435       25714.851        4771.373     3.9934176
##    Efisiensi_com
## 1      0.8687104
## 2      0.8760225
## 3      0.8867876
## 4      0.8781536
## 5      0.9127301
## 6      0.8363648
## 7      0.4347689
## 8      0.8897713
## 9      0.8818183
## 10     0.9200061
## 11     0.8985672
## 12     0.8870996
## 13     0.8546063
## 14     0.8949676
## 15     0.8865471
## 16     0.8529535
## 17     0.8542088
## 18     0.5142053
## 19     0.8336213
## 20     0.8929492
## 21     0.8473573
## 22     0.7992351
## 23     0.8202465
## 24     0.8247869
## 25     0.8579148
## 26     0.7734200
## 27     0.8453214
## 28     0.7586759
## 29     0.7543076
## 30     0.6212404
## 31     0.9021941
## 32     0.7667214
## 33     0.8455727
## 34     0.6909188
## 35     0.2498867
## 36     0.8823187
## 37     0.8858038
## 38     0.7682337

Rata-rata efisiensi:

rt_syn_4_0.5 <- mean(res_1sc2_0.5$Efisiensi_syn)
rt_com_4_0.5 <- mean(res_1sc2_0.5$Efisiensi_com)
rt_syn_4_0.5
## [1] 6.252932
rt_com_4_0.5
## [1] 0.806553
      g. f = 40%
res_1sc2_0.4
##    kab   Y dir   Y syn   Y com      MSE dir     MSE syn     MSE com
## 1    1 1627819 1457220 1595372  13661967555 70765623874 11117887018
## 2   10 2461838 2629777 2487128  12296877279 64512621437 10185643686
## 3   11 1419674 1713898 1457486  11237745018 69346855927  9425277573
## 4   12 1606572 2040026 1669603  12232130719 68567317281 10201551303
## 5   13 1635850 1435009 1613030   7918258386 67909909506  6925736274
## 6   14 2644197 2591303 2631741  16963951147 65663192444 13335316127
## 7   15 5017904 4816432 4872943 107175050073 65012940679 38503781830
## 8   16 2705339 2566454 2684114  11771003943 68625755982  9965988628
## 9   17 2013291 2258388 2046783  11715566013 67705417011  9805512618
## 10  18 1793140 1700617 1782413   8046523741 68547788616  7143816850
## 11  19 1878358 2236471 1922730  10141971305 69328333768  8740602541
## 12   2 1616477 1455015 1590893  11868938909 69291215802 10011041560
## 13  20 1878523 1515214 1809093  15499838106 69979665685 12504501268
## 14  21 1522444 1848831 1561500   9781414904 68761253740  8434200468
## 15  22 2025466 1846072 1996066  11763347876 67013174320  9838010065
## 16  23 2108607 2533650 2185096  15308600581 67725976731 12308867731
## 17  24 2678137 2676007 2676215  15937303428 67767022523 12718257240
## 18  25 3878452 3683325 3755690  89500331110 67970778550 36887225092
## 19  26 2018850 2233731 2059747  17549488451 69494149441 13710314556
## 20  27 1834772 1361079 1766629  11319350788 69272619996  9583159051
## 21  28 1629138 1872864 1674254  17008645370 69291215802 13458645651
## 22  29 1909741 2013384 1928671  20497924779 67746511901 14788519754
## 23   3 1750773 1871027 1770978  19758797405 69328333768 14952931346
## 24   4 2284572 2421378 2308705  19116386793 68489055327 14500748156
## 25   5 2049203 1879784 2018195  13857019176 67950513418 11336134757
## 26   6 2503678 2103505 2391830  23564940218 65502433848 16580546020
## 27   7 2698824 3025619 2761642  14763088671 62559509446 11666244193
## 28  71 2293864 2273770 2276290  30341244726 72323105488 20391414459
## 29  72 1857247 2042539 1897491  28982832643 73555657610 19840266123
## 30  73 3410397 3050337 3245486  55793685578 69784023076 30365181127
## 31  74 2157622 2049713 2143899  10300082065 72475812038  8940132690
## 32  75 1791985 2120565 1859499  24442831808 73293180569 16893434076
## 33  76 2079564 1959910 2052958  18525023450 73497047066 14581245162
## 34  77 2210053 2187290 2191285  38559658656 73341787428 24389850504
## 35  78 6957154 6896767 6903936 262564863669 63023484014 49296479869
## 36  79 2092725 1973719 2071743  12766347717 73082219434 10681813373
## 37   8 2014224 1732895 1970115  11603367125 68528235402  9770460516
## 38   9 2235646 2218540 2223813  18173537620 61174459439 12938736907
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         8244.350       48752.658        6887.680     5.1797535
## 2         4975.901       24525.706        4083.798     5.2462605
## 3         7799.467       40490.499        6383.751     6.1708871
## 4         7525.748       33606.447        6050.885     5.6055089
## 5         4777.923       47477.546        4254.573     8.5763695
## 6         6403.725       25337.171        5060.605     3.8707487
## 7        20994.948       13488.050        7856.030     0.6066052
## 8         4351.147       26741.105        3713.435     5.8300682
## 9         5763.758       29982.695        4752.461     5.7790991
## 10        4467.386       40368.547        3993.918     8.5189320
## 11        5368.412       30999.789        4524.129     6.8357848
## 12        7281.371       47768.059        6255.435     5.8380295
## 13        8171.598       46272.772        6869.662     4.5148643
## 14        6354.523       37221.047        5348.138     7.0297860
## 15        5761.753       36378.684        4901.405     5.6967774
## 16        7226.562       26730.122        5614.130     4.4240475
## 17        5921.521       25396.337        4736.365     4.2521009
## 18       22696.452       18455.667        9776.481     0.7594472
## 19        8619.476       31131.746        6611.549     3.9598960
## 20        6098.801       51055.021        5382.556     6.1198404
## 21       10357.749       37011.073        7994.478     4.0738821
## 22       10449.586       33758.764        7511.908     3.3050425
## 23       11115.809       37066.795        8352.518     3.5087325
## 24        8281.224       28277.294        6234.722     3.5827406
## 25        6710.745       36167.548        5587.467     4.9036891
## 26        9261.660       31162.320        6886.000     2.7796563
## 27        5447.057       20706.506        4208.397     4.2375624
## 28       12947.966       31811.898        8847.943     2.3836565
## 29       15277.657       36022.442       10307.443     2.5379044
## 30       16208.066       22869.364        9313.463     1.2507513
## 31        4768.287       35369.860        4165.929     7.0364305
## 32       13285.103       34573.570        8885.216     2.9985552
## 33        8867.682       37519.264        7083.138     3.9674469
## 34       17193.080       33533.974       11034.569     1.9020341
## 35       37085.496        9139.148        7116.678     0.2400302
## 36        6041.083       37047.991        5121.515     5.7245988
## 37        5695.723       39622.634        4920.575     5.9058922
## 38        7921.615       27598.978        5722.606     3.3661283
##    Efisiensi_com
## 1      0.8137837
## 2      0.8283114
## 3      0.8387161
## 4      0.8339963
## 5      0.8746540
## 6      0.7860973
## 7      0.3592607
## 8      0.8466558
## 9      0.8369645
## 10     0.8878141
## 11     0.8618248
## 12     0.8434656
## 13     0.8067504
## 14     0.8622679
## 15     0.8363274
## 16     0.8040492
## 17     0.7980181
## 18     0.4121462
## 19     0.7812373
## 20     0.8466174
## 21     0.7912826
## 22     0.7214642
## 23     0.7567734
## 24     0.7585507
## 25     0.8180789
## 26     0.7036108
## 27     0.7902306
## 28     0.6720691
## 29     0.6845523
## 30     0.5442405
## 31     0.8679671
## 32     0.6911406
## 33     0.7871108
## 34     0.6325225
## 35     0.1877497
## 36     0.8367165
## 37     0.8420367
## 38     0.7119548

Rata-rata efisiensi:

rt_syn_4_0.4 <- mean(res_1sc2_0.4$Efisiensi_syn)
rt_com_4_0.4 <- mean(res_1sc2_0.4$Efisiensi_com)
rt_syn_4_0.4
## [1] 4.434725
rt_com_4_0.4
## [1] 0.7515003
      h. f = 30%
res_1sc2_0.3
##    kab   Y dir   Y syn   Y com      MSE dir     MSE syn     MSE com
## 1    1 1607855 1458025 1572202  21047867931 83349892103 16047936047
## 2   10 2477012 2635120 2505397  19649179977 76940084609 15308838075
## 3   11 1369103 1702713 1418334  16347459322 81895546049 13110184079
## 4   12 1635767 2024828 1707654  19996988398 81096459097 15642809530
## 5   13 1642527 1425976 1607657  13430816149 80422565664 11054134955
## 6   14 2623778 2596654 2612086  26346672526 78119508212 19167808365
## 7   15 5098079 4844026 4896091 186569027264 77452950238 50950275200
## 8   16 2725487 2576611 2696411  18081815026 81156363252 14526421405
## 9   17 2030838 2259080 2067230  18325335545 80212945159 14434027882
## 10  18 1825502 1695525 1805304  13116683423 81076440716 11125375674
## 11  19 1819960 2232123 1881298  15377931362 81876559414 12671523976
## 12   2 1590499 1446695 1558473  18439144198 81838510650 14604538633
## 13  20 1893050 1506406 1798887  24442030583 82544224627 18380525625
## 14  21 1533499 1835180 1579967  15976789445 81295258855 13053356125
## 15  22 2017257 1841597 1978086  19613808658 79503343263 15316520399
## 16  23 2108991 2540435 2202432  24218577372 80234020450 18159427740
## 17  24 2676310 2700212 2677759  23421977845 80276095538 17732412106
## 18  25 3916200 3708754 3758937 137058968422 80484961107 46841246390
## 19  26 1987171 2200790 2035451  26939252828 82046533207 19669303250
## 20  27 1783670 1327166 1698444  18137083065 81819448521 14462699001
## 21  28 1592698 1841508 1646840  25350413476 81838510650 18803627531
## 22  29 1912693 1991006 1929018  31825897313 80255070576 20455273934
## 23   3 1739438 1859849 1757957  30599903497 81876559414 21191220421
## 24   4 2307529 2416594 2326992  30584240182 81016234587 21391383616
## 25   5 2060692 1870152 2013971  21059443056 80464187790 16159755311
## 26   6 2456396 2094479 2334201  35988855623 77954718311 23113489617
## 27   7 2689763 3060472 2775840  23314744912 74937994893 16959106809
## 28  71 2306957 2270559 2277795  45369508545 84946430312 27725785153
## 29  72 1865543 2033541 1900125  47274809907 86209890851 27857082539
## 30  73 3373017 3043822 3193203  89248650788 82343675934 41642552813
## 31  74 2105539 2041372 2093857  15586025434 85102966248 12907674112
## 32  75 1780481 2115122 1840506  33369440130 85940831735 20996777751
## 33  76 2031371 1951186 2003387  28844716989 86149810545 20854211884
## 34  77 2195552 2179510 2170999  62616938813 85990657498 33851081900
## 35  78 6913568 6867905 6869661 388979749951 75413604441 60151171561
## 36  79 2125819 1966713 2091987  19296351628 85724580378 15317730336
## 37   8 2046008 1735026 1981967  19253686511 81056397171 15175165145
## 38   9 2249658 2218546 2223479  29539666318 73518212316 18218771067
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1        12748.928        57599.74       10041.515     3.9600159
## 2         7878.478        29206.32        6081.498     3.9156893
## 3        11652.186        48146.73        9054.746     5.0096804
## 4        12075.937        40044.43        9080.071     4.0554336
## 5         7975.010        56812.04        6766.839     5.9879135
## 6         9991.638        30100.96        7317.392     2.9650616
## 7        35591.156        15993.84       10342.099     0.4151437
## 8         6629.496        31484.24        5385.229     4.4882863
## 9         8882.412        35501.16        6893.146     4.3771611
## 10        7135.297        47886.06        6132.789     6.1811693
## 11        8329.698        36651.10        6653.452     5.3242896
## 12       11389.531        56769.39        9264.974     4.4383031
## 13       12765.569        54951.06       10160.271     3.3771427
## 14       10303.924        44305.72        8187.920     5.0883351
## 15        9560.089        43246.95        7653.687     4.0534373
## 16       11391.903        31572.97        8206.510     3.3129122
## 17        8688.028        29843.14        6590.038     3.4273833
## 18       33825.105        21708.95       12343.654     0.5872287
## 19       13429.810        37306.93        9592.566     3.0456128
## 20       10035.750        62144.40        8457.531     4.5111691
## 21       15704.314        44505.54       11306.562     3.2282910
## 22       15892.121        40757.78       10279.432     2.5216907
## 23       17011.765        44041.52       11793.593     2.6757130
## 24       13069.262        33497.68        9111.690     2.6489536
## 25       10035.487        43059.73        7939.448     3.8208127
## 26       14331.858        37243.09        9815.426     2.1660794
## 27        8605.292        24568.86        6079.743     3.2141889
## 28       19061.871        37417.92       11979.547     1.8723242
## 29       24474.331        42417.33       14346.352     1.8235904
## 30       26149.935        27035.50       12972.497     0.9226322
## 31        7359.949        41714.09        6136.598     5.4602096
## 32       17592.210        40654.24       10997.740     2.5754352
## 33       13999.710        44201.88       10321.858     2.9866755
## 34       27757.137        39453.78       15405.933     1.3732811
## 35       54384.901        11029.97        8725.925     0.1938754
## 36        8943.225        43638.72        7249.798     4.4425279
## 37        9289.657        46878.96        7601.617     4.2099157
## 38       12600.152        33232.14        8042.380     2.4887963
##    Efisiensi_com
## 1      0.7624495
## 2      0.7791082
## 3      0.8019707
## 4      0.7822583
## 5      0.8230427
## 6      0.7275229
## 7      0.2730907
## 8      0.8033719
## 9      0.7876542
## 10     0.8481851
## 11     0.8240071
## 12     0.7920399
## 13     0.7520049
## 14     0.8170200
## 15     0.7809050
## 16     0.7498140
## 17     0.7570843
## 18     0.3417598
## 19     0.7301354
## 20     0.7974104
## 21     0.7417484
## 22     0.6427242
## 23     0.6925257
## 24     0.6994250
## 25     0.7673401
## 26     0.6422402
## 27     0.7273983
## 28     0.6111105
## 29     0.5892585
## 30     0.4665903
## 31     0.8281569
## 32     0.6292218
## 33     0.7229820
## 34     0.5406058
## 35     0.1546383
## 36     0.7938148
## 37     0.7881693
## 38     0.6167562

Rata-rata efisiensi:

rt_syn_4_0.3 <- mean(res_1sc2_0.3$Efisiensi_syn)
rt_com_4_0.3 <- mean(res_1sc2_0.3$Efisiensi_com)
rt_syn_4_0.3
## [1] 3.345957
rt_com_4_0.3
## [1] 0.6943564
      i. f = 20%
res_1sc2_0.2
##    kab   Y dir   Y syn   Y com      MSE dir      MSE syn     MSE com
## 1    1 1565874 1429587 1516741  34942720405 103342851663 23291144489
## 2   10 2439231 2629295 2477782  31280515784  97076158363 22702654365
## 3   11 1431553 1696380 1480315  31997654158 101920977343 22846389678
## 4   12 1639969 2024446 1723267  33406100117 101139731907 23822666408
## 5   13 1566874 1397051 1533658  19378905470 100480884747 14966912694
## 6   14 2649779 2550409 2611401  44606400762  98229248530 29660671568
## 7   15 5049695 4756906 4800989 303974422936  97577573048 66918248638
## 8   16 2692722 2531982 2650446  31162768133 101198298560 23106238534
## 9   17 1976454 2241914 2026686  32442570119 100275944519 22941305955
## 10  18 1809757 1695991 1785502  21536088203 101120160485 17232573292
## 11  19 1843529 2219376 1912538  26136324172 101902414630 19974495620
## 12   2 1619071 1457465 1573261  32770568474 101865215395 23557165304
## 13  20 1878370 1503566 1760073  43155234850 102555172629 28981205175
## 14  21 1547200 1853100 1606483  29339817179 101334092988 21726724218
## 15  22 1982165 1827205 1934959  30981843185  99582186173 22240631349
## 16  23 2046435 2495356 2161769  39060304456 100296549254 26999645287
## 17  24 2598284 2569299 2583506  37798320676 100337684916 26462477873
## 18  25 3667898 3587087 3571080 220334116336 100541887064 61261414222
## 19  26 2025389 2219617 2073681  48960322037 102068593354 31238242084
## 20  27 1804441 1321820 1696861  28362536498 101846578874 21106020658
## 21  28 1584560 1840268 1647116  41144566165 101865215395 27718206007
## 22  29 1867452 1966266 1896373  58464192785 100317129386 30206949701
## 23   3 1793928 1865073 1798043  57952172782 101902414630 33856745921
## 24   4 2310403 2411836 2328511  53429744704 101061298600 32835969973
## 25   5 1993151 1883273 1953057  37046441334 100521577561 25614324457
## 26   6 2510580 2130768 2349560  60400515984  98068137955 33181207466
## 27   7 2647037 2983702 2732304  36451353014  95118770060 24819660839
## 28  71 2292464 2236598 2244425  73017566239 104903743361 37941560746
## 29  72 1765647 2012866 1816736  72081341140 106138994139 36854771505
## 30  73 3455003 3034669 3184020 162421731143 102359101663 60032573121
## 31  74 2154906 2017647 2121144  27989660933 105056784260 21290713254
## 32  75 1783231 2086096 1840429  59290208293 105875942407 31296353096
## 33  76 1956851 1930207 1940669  46991219199 106080255268 30952082405
## 34  77 2128534 2158084 2104191  91024870062 105924655691 43470685225
## 35  78 6976462 6951251 6946537 773025841305  95583760494 80652414075
## 36  79 2095567 1944226 2052614  33770266000 105664519376 24062798334
## 37   8 2006574 1709529 1930901  29728581101 101100564459 22005633193
## 38   9 2258432 2245263 2229525  52934909164  93730687506 27517427334
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         21171.41        72669.70       15000.866     2.9574930
## 2         12663.61        36842.44        9083.475     3.1034066
## 3         21523.36        60120.03       14993.710     3.1852640
## 4         19858.07        49887.63       13566.397     3.0275827
## 5         11917.46        72507.98        9573.369     5.1850650
## 6         16724.43        38479.06       11315.846     2.2021335
## 7         57624.76        20469.94       13816.819     0.3210059
## 8         11567.65        39898.96        8720.677     3.2474104
## 9         15938.50        44691.94       11061.647     3.0908755
## 10        11819.04        59714.28        9616.804     4.6953820
## 11        13934.35        45849.66       10291.897     3.8988809
## 12        19805.90        70232.60       14783.111     3.1084360
## 13        22512.88        68351.47       16289.794     2.3764249
## 14        18534.27        54712.88       13287.290     3.4538079
## 15        15249.25        54750.67       11338.953     3.2142112
## 16        18854.97        40137.45       12389.445     2.5677360
## 17        14333.81        39296.84       10168.413     2.6545540
## 18        57199.67        28016.27       16980.439     0.4563156
## 19        23487.32        46107.41       14813.873     2.0847206
## 20        15294.66        78019.31       12274.663     3.5908840
## 21        25296.68        55535.52       16565.248     2.4757878
## 22        29088.54        51940.69       15202.004     1.7158730
## 23        31118.87        54568.76       18423.106     1.7583882
## 24        22504.13        41830.22       13870.414     1.8914801
## 25        18091.91        53346.01       12922.137     2.7133936
## 26        22940.14        46031.76       13910.134     1.6236308
## 27        13520.02        31923.00        8974.150     2.6094716
## 28        30560.55        46805.64       16587.960     1.4366919
## 29        38089.73        52648.39       19468.570     1.4724892
## 30        45962.79        33655.88       18677.524     0.6302057
## 31        12916.75        51990.32        9997.575     3.7534140
## 32        30520.56        50667.37       16290.204     1.7857239
## 33        23802.69        54891.31       15855.558     2.2574485
## 34        40542.41        48981.99       20220.476     1.1636892
## 35       105975.37        13777.74       11569.771     0.1236489
## 36        15824.89        54276.16       11603.082     3.1289217
## 37        14464.52        59226.76       11246.740     3.4007867
## 38        22021.77        41822.39       11989.925     1.7706782
##    Efisiensi_com
## 1      0.6665521
## 2      0.7257762
## 3      0.7140020
## 4      0.7131232
## 5      0.7723301
## 6      0.6649421
## 7      0.2201443
## 8      0.7414694
## 9      0.7071359
## 10     0.8001719
## 11     0.7642427
## 12     0.7188513
## 13     0.6715571
## 14     0.7405201
## 15     0.7178602
## 16     0.6912298
## 17     0.7000967
## 18     0.2780387
## 19     0.6380318
## 20     0.7441514
## 21     0.6736784
## 22     0.5166744
## 23     0.5842187
## 24     0.6145635
## 25     0.6914112
## 26     0.5493530
## 27     0.6808982
## 28     0.5196224
## 29     0.5112942
## 30     0.3696092
## 31     0.7606635
## 32     0.5278503
## 33     0.6586780
## 34     0.4775693
## 35     0.1043334
## 36     0.7125439
## 37     0.7402181
## 38     0.5198352

Rata-rata efisiensi:

rt_syn_4_0.2 <- mean(res_1sc2_0.2$Efisiensi_syn)
rt_com_4_0.2 <- mean(res_1sc2_0.2$Efisiensi_com)
rt_syn_4_0.2
## [1] 2.477192
rt_com_4_0.2
## [1] 0.6211379
      j. f = 10%
res_1sc2_0.1
##    kab   Y dir   Y syn   Y com      MSE dir      MSE syn      MSE com
## 1    1 1474412 1370798 1408539 8.362945e+10 159612586183  43752503692
## 2   10 2466415 2566205 2480810 7.489146e+10 156328374943  45417954302
## 3   11 1350222 1629922 1397207 6.121087e+10 158867418772  38308228331
## 4   12 1616836 1943930 1687074 7.068443e+10 158457988325  43661237002
## 5   13 1600199 1341919 1527684 4.784029e+10 158112703635  31131279140
## 6   14 2508111 2504699 2493060 9.621367e+10 156932679558  54892374717
## 7   15 5044368 4718471 4742577 7.622693e+11 156591153359 111301711694
## 8   16 2715099 2485802 2631875 6.977470e+10 158488681586  44297194777
## 9   17 1988602 2188734 2013662 6.920891e+10 158005299783  39914912483
## 10  18 1803904 1634797 1751655 5.054491e+10 158447731450  36092032976
## 11  19 1740350 2154349 1825054 5.875218e+10 158857690536  38225133646
## 12   2 1492548 1393112 1443008 6.460725e+10 158838195383  40465978469
## 13  20 1864903 1435537 1696934 9.058667e+10 159199784054  51721261613
## 14  21 1547052 1778241 1586802 6.331594e+10 158559847920  39960794315
## 15  22 1822352 1783252 1795658 5.326715e+10 157641719047  35852020502
## 16  23 2016878 2448800 2143203 8.742033e+10 158016098190  51175956338
## 17  24 2550396 2573544 2543403 8.595585e+10 158037656322  49683594031
## 18  25 3732677 3568919 3546583 5.009683e+11 158144673365  94158927465
## 19  26 1864495 2133159 1927061 9.994400e+10 158944780490  52580791555
## 20  27 1736203 1243860 1594039 6.296103e+10 158828428466  40215621869
## 21  28 1476617 1755054 1547730 8.930235e+10 158838195383  51255606492
## 22  29 1838937 1885023 1846663 1.155261e+11 158026883702  48946534379
## 23   3 1649226 1786829 1647038 1.085560e+11 158857690536  51962825174
## 24   4 2320461 2344984 2287871 1.255233e+11 158416883465  59139949475
## 25   5 2029842 1808988 1919844 9.071582e+10 158134029682  50104913859
## 26   6 2418303 2052249 2235449 1.281240e+11 156848245690  56192595328
## 27   7 2502185 2960117 2640099 8.123614e+10 155302558558  45595053195
## 28  71 2276058 2163693 2160286 1.734592e+11 160430608993  64087066256
## 29  72 1486706 1933537 1566103 1.121681e+11 161077971852  45558891776
## 30  73 3195014 2946242 2983750 3.336357e+11 159097028352  94845968261
## 31  74 1947222 1939601 1939653 5.348505e+10 160510813754  36934879769
## 32  75 1875994 2011022 1871665 1.473517e+11 160940113270  57964574521
## 33  76 1734900 1851219 1742521 8.519009e+10 161047188335  47667639874
## 34  77 2152122 2078441 2046394 2.169290e+11 160965642637  72715137506
## 35  78 6842669 6805761 6800201 1.330918e+12 155546247970 129761399654
## 36  79 2085723 1866890 1999909 7.450703e+10 160829311949  43693765520
## 37   8 2011617 1652253 1889569 7.095530e+10 158437461682  43554545110
## 38   9 2141691 2181358 2132120 7.494735e+10 154575100533  39477923540
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         50980.13       118192.35        30064.24     1.9085691
## 2         29624.74        61171.65        18079.33     2.0873992
## 3         41908.25        97565.63        26050.86     2.5954120
## 4         41642.07        81394.83        25049.28     2.2417665
## 5         27568.79       120198.69        19875.01     3.3050115
## 6         37971.81        62723.53        21915.60     1.6310851
## 7        139614.90        33168.12        23141.23     0.2054276
## 8         25436.31        63669.14        16762.74     2.2714349
## 9         32648.67        72178.65        19029.73     2.2830196
## 10        27379.45        97518.54        20334.40     3.1347908
## 11        32290.85        73612.61        20150.73     2.7038604
## 12        40601.79       115683.38        27157.00     2.4585197
## 13        46449.76       111618.60        30002.86     1.7574305
## 14        38806.74        89456.14        24228.81     2.5042643
## 15        27683.59        89039.74        19377.62     2.9594549
## 16        42051.08        64419.29        23390.68     1.8075442
## 17        32734.03        62063.07        19172.48     1.8385910
## 18       118624.64        44280.98        25922.40     0.3156780
## 19        50825.85        74562.67        26438.66     1.5903384
## 20        34407.02       130579.15        24704.95     2.5226465
## 21        57622.06        90761.05        32140.27     1.7786564
## 22        54986.88        87112.39        25079.95     1.3678892
## 23        59094.43        89006.66        30052.67     1.4633709
## 24        51033.57        67500.94        25250.72     1.2620521
## 25        42089.79        87792.12        25545.87     1.7431802
## 26        48838.71        77156.76        24704.44     1.2241907
## 27        31376.48        53058.82        17123.90     1.9117423
## 28        67088.48        73988.44        28516.84     0.9248897
## 29        63413.38        83175.80        26996.81     1.4360405
## 30        99634.47        54166.79        31399.70     0.4768585
## 31        27437.06        82632.19        18997.32     3.0010405
## 32        67648.57        79885.31        29604.40     1.0922176
## 33        46036.31        86910.09        26330.35     1.8904452
## 34        89857.63        77316.54        34296.14     0.7420200
## 35       181235.66        23157.42        19128.68     0.1168714
## 36        33692.69        86079.89        21312.76     2.1585792
## 37        33578.41        96678.95        22587.86     2.2329193
## 38        31802.75        71893.55        18004.97     2.0624492
##    Efisiensi_com
## 1      0.5231710
## 2      0.6064504
## 3      0.6258403
## 4      0.6176924
## 5      0.6507335
## 6      0.5705257
## 7      0.1460136
## 8      0.6348604
## 9      0.5767308
## 10     0.7140587
## 11     0.6506164
## 12     0.6263381
## 13     0.5709588
## 14     0.6311332
## 15     0.6730606
## 16     0.5854011
## 17     0.5780129
## 18     0.1879539
## 19     0.5261025
## 20     0.6387383
## 21     0.5739558
## 22     0.4236838
## 23     0.4786730
## 24     0.4711474
## 25     0.5523283
## 26     0.4385797
## 27     0.5612657
## 28     0.3694648
## 29     0.4061661
## 30     0.2842800
## 31     0.6905645
## 32     0.3933757
## 33     0.5595444
## 34     0.3352025
## 35     0.0974977
## 36     0.5864382
## 37     0.6138307
## 38     0.5267421

Rata-rata efisiensi:

rt_syn_4_0.1 <- mean(res_1sc2_0.1$Efisiensi_syn)
rt_com_4_0.1 <- mean(res_1sc2_0.1$Efisiensi_com)
rt_syn_4_0.1
## [1] 1.815991
rt_com_4_0.1
## [1] 0.5183456
      k. f = 5%
res_1sc2_0.05
##    kab   Y dir   Y syn   Y com      MSE dir      MSE syn      MSE com
## 1    1 1485403 1304574 1364953 1.811192e+11 251230651475  68547113291
## 2   10 2442296 2481150 2406162 1.515579e+11 241702326871  74379537028
## 3   11 1208853 1502209 1219021 1.221906e+11 249068732993  57242281287
## 4   12 1680146 1740627 1631528 1.729213e+11 247880872067  77529072823
## 5   13 1533738 1279680 1459492 7.573877e+10 246879114153  45530693243
## 6   14 2284936 2476581 2316674 1.847637e+11 243455566878  86213301074
## 7   15 5178744 4622091 4651671 1.498139e+12 242464713292 162971191276
## 8   16 2696329 2436228 2582384 1.570469e+11 247969920955  80954863442
## 9   17 1978475 2118127 1959442 1.508735e+11 246567508506  67132370943
## 10  18 1868387 1551065 1744843 1.172519e+11 247851114289  67009635228
## 11  19 1469693 2019440 1562325 1.045470e+11 249040508928  55659934395
## 12   2 1302446 1303857 1269988 1.119387e+11 248983948575  60666515786
## 13  20 1601115 1315922 1455872 1.640984e+11 250033008450  72587782844
## 14  21 1490601 1618456 1481196 1.199529e+11 248176392428  64255635547
## 15  22 1819501 1752638 1767090 1.162658e+11 245512669151  59798927872
## 16  23 2066684 2393656 2135937 1.686773e+11 246598837405  80299343947
## 17  24 2649619 2708026 2629414 2.278901e+11 246661382981  93778060593
## 18  25 3613853 3578190 3497698 7.438193e+11 246971866398 133084531538
## 19  26 1558812 1853655 1599005 1.781009e+11 249293178837  72070568211
## 20  27 1428695 1030543 1330370 8.997022e+10 248955612287  50518667556
## 21  28 1259832 1527781 1296738 1.375232e+11 248983948575  68484352245
## 22  29 1876570 1793521 1833274 2.011090e+11 246630128897  72403913328
## 23   3 1454547 1610971 1422261 2.355839e+11 249040508928  79574964482
## 24   4 2259415 2208072 2171153 2.332514e+11 247761616508  92479021234
## 25   5 1982878 1665994 1825378 1.822995e+11 246940986391  76335594867
## 26   6 2099242 1902682 1953710 2.466143e+11 243210602943  87833968045
## 27   7 2492877 3062151 2676435 1.729104e+11 238726174978  80509570570
## 28  71 2394477 1979750 2141934 4.318978e+11 253603941830 113497682319
## 29  72 1575159 1724349 1507646 3.302861e+11 255482104653  80305727987
## 30  73 2767888 2721627 2630555 6.188210e+11 249734888258 132075660385
## 31  74 1530206 1741402 1557813 8.983359e+10 253836636059  48821580303
## 32  75 1476924 1820247 1506972 1.478340e+11 255082142159  57589660700
## 33  76 1679902 1647915 1622698 1.493627e+11 255392793911  61591664309
## 34  77 1794893 1869024 1746474 3.493149e+11 255156209288  86090631451
## 35  78 6238848 6238045 6214107 2.833200e+12 239433179387 190917651071
## 36  79 1648235 1674959 1611362 1.182821e+11 254760679599  49578885735
## 37   8 2016827 1598346 1837371 1.533652e+11 247821319103  77002313177
## 38   9 2087040 2120534 2031603 2.532612e+11 236615635891  76957599030
##    Relatif MSE dir Relatif MSE syn Relatif MSE com Efisiensi_syn
## 1         95063.73       205152.04        47025.33     1.3871008
## 2         58396.50        97202.19        30090.21     1.5947853
## 3         80873.08       166412.64        42137.16     2.0383620
## 4         92853.66       141625.04        45016.53     1.4334898
## 5         44626.29       201738.02        30533.13     3.2596135
## 6         77644.69        98526.51        36069.82     1.3176594
## 7        245667.61        52646.31        34424.89     0.1618440
## 8         57181.21       101439.44        31092.33     1.5789541
## 9         66206.35       116396.88        32213.50     1.6342669
## 10        59148.03       161075.89        37669.20     2.1138339
## 11        63588.99       122845.35        32573.09     2.3820919
## 12        76877.36       195465.13        45396.58     2.2242886
## 13        88368.32       193145.52        46977.97     1.5236774
## 14        70806.04       153705.44        40388.53     2.0689484
## 15        56908.38       143080.34        32401.41     2.1116502
## 16        76308.53       102818.12        36263.43     1.4619559
## 17        80051.34        93514.28        34389.63     1.0823697
## 18       178002.47        69212.86        37342.93     0.3320321
## 19        98611.26       137230.00        42129.74     1.3997302
## 20        55742.33       260120.48        36246.94     2.7670890
## 21        96247.41       164797.09        48778.88     1.8104871
## 22        86549.76       144996.53        36977.00     1.2263507
## 23       127609.90       154209.70        51317.79     1.0571203
## 24        91881.27       111814.51        41092.86     1.0622083
## 25        82899.26       148322.01        41190.55     1.3545893
## 26        97468.79       128387.87        42916.21     0.9861985
## 27        63206.31        78603.86        29059.69     1.3806352
## 28       157588.40       127330.71        51831.98     0.5871851
## 29       149935.84       147825.46        47446.24     0.7735176
## 30       198554.92        91360.46        48364.53     0.4035656
## 31        57115.04       145303.19        30142.11     2.8256317
## 32        83958.77       139714.77        34407.30     1.7254631
## 33        77947.82       155167.01        35788.36     1.7098831
## 34       156870.54       135753.20        47348.72     0.7304476
## 35       376731.62        40163.29        30740.14     0.0845098
## 36        60558.81       152271.43        28538.07     2.1538388
## 37        70489.54       157199.41        41299.80     1.6158904
## 38        97029.52       113013.19        36505.30     0.9342752
##    Efisiensi_com
## 1     0.37846400
## 2     0.49076644
## 3     0.46846704
## 4     0.44834897
## 5     0.60115438
## 6     0.46661395
## 7     0.10878245
## 8     0.51548194
## 9     0.44495812
## 10    0.57150132
## 11    0.53239162
## 12    0.54196200
## 13    0.44234304
## 14    0.53567382
## 15    0.51432954
## 16    0.47605292
## 17    0.41150557
## 18    0.17892050
## 19    0.40466148
## 20    0.56150430
## 21    0.49798406
## 22    0.36002328
## 23    0.33777761
## 24    0.39647781
## 25    0.41873720
## 26    0.35615933
## 27    0.46561441
## 28    0.26278831
## 29    0.24313990
## 30    0.21343111
## 31    0.54346688
## 32    0.38955623
## 33    0.41236302
## 34    0.24645567
## 35    0.06738586
## 36    0.41915781
## 37    0.50208472
## 38    0.30386654

Rata-rata efisiensi:

rt_syn_4_0.05 <- mean(res_1sc2_0.05$Efisiensi_syn)
rt_com_4_0.05 <- mean(res_1sc2_0.05$Efisiensi_com)
rt_syn_4_0.05
## [1] 1.481462
rt_com_4_0.05
## [1] 0.4086935