Sites para Consultar sobre Regressao Linear: Mapas de Correlação: https://rpubs.com/melinatarituba/353262

#Modelos de Regressão

1.Regressao Linear Simples

(Variavel dependente: numerica, variavel independente : numerica)

##Exportação de Dados

set.seed(1)
galton_heights <- GaltonFamilies %>%
  filter(gender == "male") %>%
  select(father, childHeight) %>%
  rename(son = childHeight)
head(galton_heights)
##   father  son
## 1   78.5 73.2
## 2   75.5 73.5
## 3   75.5 72.5
## 4   75.0 71.0
## 5   75.0 70.5
## 6   75.0 68.5
y <- galton_heights$son
test_index <- createDataPartition(y, times = 1, p = 0.5, list = FALSE)
train_set <- galton_heights %>% slice(-test_index)
test_set <- galton_heights %>% slice(test_index)

Exploração dos dados

cor(galton_heights)
##           father       son
## father 1.0000000 0.3923835
## son    0.3923835 1.0000000
hist(galton_heights$father)

hist(galton_heights$son)

boxplot(galton_heights$father, 
        col = c('gray', 'red'), main = 'Father')

boxplot(galton_heights$son, 
        col = c('gray', 'red'), main = 'Son')

## Criação e estudo do Modelo de Regressão Linear

set.seed(1)
RMSE = function(m, o){
  sqrt(mean((m - o)^2))
}
fit = lm(son ~ father, data = train_set)
fit$coef
## (Intercept)      father 
##  37.5542392   0.4576287
y_hat<- predict(fit, test_set)
summary(fit) #P-VALUE < 0.05 and R-SQUARED >=0.7
## 
## Call:
## lm(formula = son ~ father, data = train_set)
## 
## Residuals:
##    Min     1Q Median     3Q    Max 
## -6.131 -1.549  0.005  1.609  5.954 
## 
## Coefficients:
##             Estimate Std. Error t value Pr(>|t|)    
## (Intercept) 37.55424    4.63428   8.104 2.80e-14 ***
## father       0.45763    0.06694   6.836 6.77e-11 ***
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1
## 
## Residual standard error: 2.415 on 238 degrees of freedom
## Multiple R-squared:  0.1641, Adjusted R-squared:  0.1606 
## F-statistic: 46.74 on 1 and 238 DF,  p-value: 6.771e-11
par(mfrow=c(2,2))
plot(fit)

shapiro.test(fit$residuals) #P-VALUE > 0.05
## 
##  Shapiro-Wilk normality test
## 
## data:  fit$residuals
## W = 0.99482, p-value = 0.5896
RMSE(y_hat, test_set$son)
## [1] 2.417579

#2.Regressao Linear Multipla (Variavel dependente: numerica, 2 variavel independente : numerica)

set.seed(1)
Sigma <- matrix(c(1.0, 0.75, 0.75, 0.75, 1.0, 0.25, 0.75, 0.25, 1.0), 3, 3)
dat <- MASS::mvrnorm(n = 100, c(0, 0, 0), Sigma) %>%
  data.frame() %>% setNames(c("y", "x_1", "x_2"))
head(dat)
##             y         x_1         x_2
## 1 -0.54335401 -0.15627188 -0.91606278
## 2  0.48203339 -0.07151714 -0.01993594
## 3 -0.53913301 -0.27408300 -1.38972961
## 4  1.51064005  1.18876647  1.38231139
## 5 -0.08352236  0.91504731  0.11334813
## 6 -0.36165800 -2.00447523  0.16000079
y <- dat$y
test_index <- createDataPartition(y, times = 1, p = 0.5, list = FALSE)
train_set <- dat %>% slice(-test_index)
test_set <- dat %>% slice(test_index)

##Exploração dos dados

panel.hist <- function(x, ...)
{
  usr <- par("usr"); on.exit(par(usr))
  par(usr = c(usr[1:2], 0, 1.5) )
  h <- hist(x, plot = FALSE)
  breaks <- h$breaks; nB <- length(breaks)
  y <- h$counts; y <- y/max(y)
  rect(breaks[-nB], 0, breaks[-1], y, col = "cyan", ...)
}
panel.cor <- function(x, y, digits = 2, prefix = "", cex.cor, ...)
{
  usr <- par("usr"); on.exit(par(usr))
  par(usr = c(0, 1, 0, 1))
  r <- abs(cor(x, y))
  txt <- format(c(r, 0.123456789), digits = digits)[1]
  txt <- paste0(prefix, txt)
  if(missing(cex.cor)) cex.cor <- 0.8/strwidth(txt)
  text(0.5, 0.5, txt, cex = cex.cor * r)
}
pairs(dat, diag.panel = panel.hist, upper.panel = panel.cor,
      lower.panel = panel.smooth)

##Criação e estudo do Modelo de Regressao Linear

set.seed(1)
'Metodo backward'
## [1] "Metodo backward"
fit1=step(lm(y~x_1+x_2,data=train_set),direction="backward")
## Start:  AIC=-108.64
## y ~ x_1 + x_2
## 
##        Df Sum of Sq     RSS      AIC
## <none>               4.4056 -108.640
## - x_2   1    11.862 16.2678  -47.937
## - x_1   1    12.508 16.9138  -46.067
'Metodo Forward'
## [1] "Metodo Forward"
fit2=step(lm(y ~ 1,data=train_set),direction="forward",scope= ~ x_1+x_2)
## Start:  AIC=-19.4
## y ~ 1
## 
##        Df Sum of Sq    RSS     AIC
## + x_1   1    14.463 16.268 -47.937
## + x_2   1    13.817 16.914 -46.067
## <none>              30.731 -19.405
## 
## Step:  AIC=-47.94
## y ~ x_1
## 
##        Df Sum of Sq     RSS      AIC
## + x_2   1    11.862  4.4056 -108.640
## <none>              16.2678  -47.937
## 
## Step:  AIC=-108.64
## y ~ x_1 + x_2
'Metodo Both'
## [1] "Metodo Both"
fit3=step(lm(y~x_1+x_2,data=train_set),direction="both")
## Start:  AIC=-108.64
## y ~ x_1 + x_2
## 
##        Df Sum of Sq     RSS      AIC
## <none>               4.4056 -108.640
## - x_2   1    11.862 16.2678  -47.937
## - x_1   1    12.508 16.9138  -46.067
set.seed(1)
RMSE = function(m, o){
  sqrt(mean((m - o)^2))
}

fit$coef
## (Intercept)      father 
##  37.5542392   0.4576287
y_hat<- predict(fit1, test_set)
summary(fit1) #P-VALUE < 0.05 and R-SQUARED >=0.7
## 
## Call:
## lm(formula = y ~ x_1 + x_2, data = train_set)
## 
## Residuals:
##      Min       1Q   Median       3Q      Max 
## -0.72036 -0.14458  0.03871  0.13701  0.76467 
## 
## Coefficients:
##             Estimate Std. Error t value Pr(>|t|)    
## (Intercept) 0.002307   0.045905    0.05     0.96    
## x_1         0.624204   0.055223   11.30 9.77e-15 ***
## x_2         0.558975   0.050781   11.01 2.36e-14 ***
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1
## 
## Residual standard error: 0.3129 on 45 degrees of freedom
## Multiple R-squared:  0.8566, Adjusted R-squared:  0.8503 
## F-statistic: 134.4 on 2 and 45 DF,  p-value: < 2.2e-16
par(mfrow=c(2,2))
plot(fit1)

shapiro.test(fit1$residuals) #P-VALUE > 0.05
## 
##  Shapiro-Wilk normality test
## 
## data:  fit1$residuals
## W = 0.96896, p-value = 0.2307
fit1$coef
## (Intercept)         x_1         x_2 
## 0.002307117 0.624204386 0.558974981
y_hat<- predict(fit1, test_set)
summary(fit1) #P-VALUE < 0.05 and R-SQUARED >=0.7
## 
## Call:
## lm(formula = y ~ x_1 + x_2, data = train_set)
## 
## Residuals:
##      Min       1Q   Median       3Q      Max 
## -0.72036 -0.14458  0.03871  0.13701  0.76467 
## 
## Coefficients:
##             Estimate Std. Error t value Pr(>|t|)    
## (Intercept) 0.002307   0.045905    0.05     0.96    
## x_1         0.624204   0.055223   11.30 9.77e-15 ***
## x_2         0.558975   0.050781   11.01 2.36e-14 ***
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1
## 
## Residual standard error: 0.3129 on 45 degrees of freedom
## Multiple R-squared:  0.8566, Adjusted R-squared:  0.8503 
## F-statistic: 134.4 on 2 and 45 DF,  p-value: < 2.2e-16
vif<-function (obj, digits = 5) {
     Qr <- obj$qr
     if (is.null(obj$terms) || is.null(Qr))
         stop("invalid 'lm' object:  no terms or qr component")
     tt <- terms(obj)
     hasintercept <- attr(tt, "intercept") > 0
     p <- Qr$rank
     if (hasintercept)
         p1 <- 2:p
     else p1 <- 1:p
     R <- Qr$qr[p1, p1, drop = FALSE]
     if (length(p1) > 1)
         R[row(R) > col(R)] <- 0
     Rinv <- qr.solve(R)
     vv <- apply(Rinv, 1, function(x) sum(x^2))
     ss <- apply(R, 2, function(x) sum(x^2))
     vif <- ss * vv
     signif(vif, digits)
}
vif(fit1) #<=5
##    x_1    x_2 
## 1.0055 1.0055
RMSE(y_hat, test_set$y)
## [1] 0.345693
train_lm <- train(y ~ ., method = "lm", data = train_set)
summary(train_lm)
## 
## Call:
## lm(formula = .outcome ~ ., data = dat)
## 
## Residuals:
##      Min       1Q   Median       3Q      Max 
## -0.72036 -0.14458  0.03871  0.13701  0.76467 
## 
## Coefficients:
##             Estimate Std. Error t value Pr(>|t|)    
## (Intercept) 0.002307   0.045905    0.05     0.96    
## x_1         0.624204   0.055223   11.30 9.77e-15 ***
## x_2         0.558975   0.050781   11.01 2.36e-14 ***
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1
## 
## Residual standard error: 0.3129 on 45 degrees of freedom
## Multiple R-squared:  0.8566, Adjusted R-squared:  0.8503 
## F-statistic: 134.4 on 2 and 45 DF,  p-value: < 2.2e-16
y_hat<- predict(train_lm, test_set)
RMSE(y_hat, test_set$y)
## [1] 0.345693

3.Regressao Adaptada

(Variavel dependente: Categorica, 2 variavel independente : numerica)

library(dslabs)
data("heights")
y <- heights$height
head(heights)
##      sex height
## 1   Male     75
## 2   Male     70
## 3   Male     68
## 4   Male     74
## 5   Male     61
## 6 Female     65
set.seed(1)
test_index <- createDataPartition(y, times = 1, p = 0.5, list = FALSE)
train_set <- heights %>% slice(-test_index)
test_set <- heights %>% slice(test_index)

##Exploração dos dados

ggpairs(heights, columns = 1:2, ggplot2::aes(colour=sex))
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

heights %>% 
  mutate(x = round(height)) %>%
  group_by(x) %>%
  filter(n() >= 10) %>%
  summarize(prop = mean(sex == "Female")) %>%
  ggplot(aes(x, prop)) +
  geom_point()

##Criação e estudo do Modelo de Regressao

set.seed(1)
'Metodo backward'
## [1] "Metodo backward"
fit=fit1=step(mutate(train_set, y = as.numeric(sex == "Female")) %>% lm(y ~ height, data = .),direction="backward")
## Start:  AIC=-1032.24
## y ~ height
## 
##          Df Sum of Sq    RSS      AIC
## <none>                72.525 -1032.24
## - height  1    17.795 90.321  -919.26
'Metodo Both'
## [1] "Metodo Both"
fit3=step(mutate(train_set, y = as.numeric(sex == "Female")) %>% lm(y ~ height, data = .),direction="both")
## Start:  AIC=-1032.24
## y ~ height
## 
##          Df Sum of Sq    RSS      AIC
## <none>                72.525 -1032.24
## - height  1    17.795 90.321  -919.26
set.seed(1)
RMSE = function(m, o){
  sqrt(mean((m - o)^2))
}
fit$coef
## (Intercept)      height 
##  3.22703654 -0.04396611
y_hat<- predict(fit, test_set)
summary(fit) #P-VALUE < 0.05 and R-SQUARED >=0.7
## 
## Call:
## lm(formula = y ~ height, data = .)
## 
## Residuals:
##      Min       1Q   Median       3Q      Max 
## -0.86298 -0.23734 -0.11133  0.07042  1.24629 
## 
## Coefficients:
##              Estimate Std. Error t value Pr(>|t|)    
## (Intercept)  3.227037   0.266080   12.13   <2e-16 ***
## height      -0.043966   0.003885  -11.32   <2e-16 ***
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1
## 
## Residual standard error: 0.3727 on 522 degrees of freedom
## Multiple R-squared:  0.197,  Adjusted R-squared:  0.1955 
## F-statistic: 128.1 on 1 and 522 DF,  p-value: < 2.2e-16
p_hat <- predict(fit, test_set)
y_hat <- ifelse(p_hat > 0.5, "Female", "Male") %>% factor()
confusionMatrix(y_hat, test_set$sex)
## Confusion Matrix and Statistics
## 
##           Reference
## Prediction Female Male
##     Female     22   12
##     Male      100  392
##                                           
##                Accuracy : 0.7871          
##                  95% CI : (0.7496, 0.8213)
##     No Information Rate : 0.7681          
##     P-Value [Acc > NIR] : 0.1633          
##                                           
##                   Kappa : 0.2013          
##                                           
##  Mcnemar's Test P-Value : <2e-16          
##                                           
##             Sensitivity : 0.18033         
##             Specificity : 0.97030         
##          Pos Pred Value : 0.64706         
##          Neg Pred Value : 0.79675         
##              Prevalence : 0.23194         
##          Detection Rate : 0.04183         
##    Detection Prevalence : 0.06464         
##       Balanced Accuracy : 0.57531         
##                                           
##        'Positive' Class : Female          
## 

#4.Regressao Logistica
(Variavel dependente: Categorica, variavel independente : numerica)

Exportação de Dados

library(dslabs)
data("heights")
y <- heights$height
head(heights)
##      sex height
## 1   Male     75
## 2   Male     70
## 3   Male     68
## 4   Male     74
## 5   Male     61
## 6 Female     65
set.seed(2)
test_index <- createDataPartition(y, times = 1, p = 0.5, list = FALSE)
train_set <- heights %>% slice(-test_index)
test_set <- heights %>% slice(test_index)

Criação do Modelo de Regressao Logistica

# fit logistic regression model
glm_fit <- train_set %>% 
  mutate(y = as.numeric(sex == "Female")) %>%
  glm(y ~ height, data=., family = "binomial")
summary(glm_fit)
## 
## Call:
## glm(formula = y ~ height, family = "binomial", data = .)
## 
## Deviance Residuals: 
##     Min       1Q   Median       3Q      Max  
## -2.9596  -0.6541  -0.4276  -0.2222   3.1575  
## 
## Coefficients:
##             Estimate Std. Error z value Pr(>|z|)    
## (Intercept) 20.47888    2.56809   7.974 1.53e-15 ***
## height      -0.32224    0.03842  -8.388  < 2e-16 ***
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1
## 
## (Dispersion parameter for binomial family taken to be 1)
## 
##     Null deviance: 556.52  on 523  degrees of freedom
## Residual deviance: 453.62  on 522  degrees of freedom
## AIC: 457.62
## 
## Number of Fisher Scoring iterations: 5
p_hat_logit <- predict(glm_fit, newdata = test_set, type = "response")
y_hat_logit <- ifelse(p_hat_logit > 0.5, "Female", "Male") %>% factor
confusionMatrix(y_hat_logit, test_set$sex)
## Confusion Matrix and Statistics
## 
##           Reference
## Prediction Female Male
##     Female     46   21
##     Male       75  384
##                                           
##                Accuracy : 0.8175          
##                  95% CI : (0.7818, 0.8496)
##     No Information Rate : 0.77            
##     P-Value [Acc > NIR] : 0.004726        
##                                           
##                   Kappa : 0.3892          
##                                           
##  Mcnemar's Test P-Value : 6.328e-08       
##                                           
##             Sensitivity : 0.38017         
##             Specificity : 0.94815         
##          Pos Pred Value : 0.68657         
##          Neg Pred Value : 0.83660         
##              Prevalence : 0.23004         
##          Detection Rate : 0.08745         
##    Detection Prevalence : 0.12738         
##       Balanced Accuracy : 0.66416         
##                                           
##        'Positive' Class : Female          
## 
train_glm <- train(sex ~ ., method = "glm", data = train_set)
y_hat_glm <- predict(train_glm, test_set, type = "raw")
confusionMatrix(y_hat_glm, test_set$sex)
## Confusion Matrix and Statistics
## 
##           Reference
## Prediction Female Male
##     Female     46   21
##     Male       75  384
##                                           
##                Accuracy : 0.8175          
##                  95% CI : (0.7818, 0.8496)
##     No Information Rate : 0.77            
##     P-Value [Acc > NIR] : 0.004726        
##                                           
##                   Kappa : 0.3892          
##                                           
##  Mcnemar's Test P-Value : 6.328e-08       
##                                           
##             Sensitivity : 0.38017         
##             Specificity : 0.94815         
##          Pos Pred Value : 0.68657         
##          Neg Pred Value : 0.83660         
##              Prevalence : 0.23004         
##          Detection Rate : 0.08745         
##    Detection Prevalence : 0.12738         
##       Balanced Accuracy : 0.66416         
##                                           
##        'Positive' Class : Female          
## 

#5. Regressão Local (Loess)

(Variavel dependente: Categorica, variavel independente : numerica)

grid <- expand.grid(span = seq(0.15, 0.65, len = 10), degree = 1)
train_loess <- train(sex ~ ., 
                     method = "gamLoess",
                     tuneGrid=grid,
                     data = train_set)
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 80
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 79.145
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : lowerlimit 51.847
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.15
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored

## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.15, degree = 1)"]], z, w, span
## = 0.15, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.205555555555556, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.261111111111111, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.316666666666667, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.372222222222222, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.427777777777778, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.483333333333333, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.538888888888889, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.594444444444444, degree =
## 1)"]], : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 82.677
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : upperlimit 80.14
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : eval 50
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : lowerlimit 51.86
## Warning in gam.lo(data[["lo(height, span = 0.65, degree = 1)"]], z, w, span
## = 0.65, : extrapolation not allowed with blending
## Warning in model.matrix.default(mt, mf, contrasts): non-list contrasts
## argument ignored
ggplot(train_loess, highlight = TRUE)

confusionMatrix(data = predict(train_loess, test_set), 
                reference = test_set$sex)
## Confusion Matrix and Statistics
## 
##           Reference
## Prediction Female Male
##     Female     71   43
##     Male       50  362
##                                           
##                Accuracy : 0.8232          
##                  95% CI : (0.7879, 0.8549)
##     No Information Rate : 0.77            
##     P-Value [Acc > NIR] : 0.001725        
##                                           
##                   Kappa : 0.4906          
##                                           
##  Mcnemar's Test P-Value : 0.533829        
##                                           
##             Sensitivity : 0.5868          
##             Specificity : 0.8938          
##          Pos Pred Value : 0.6228          
##          Neg Pred Value : 0.8786          
##              Prevalence : 0.2300          
##          Detection Rate : 0.1350          
##    Detection Prevalence : 0.2167          
##       Balanced Accuracy : 0.7403          
##                                           
##        'Positive' Class : Female          
##