27 low[
tj] = x[
tj] - asydecr * (xold1[
tj] - low[
tj]);
28 upp[
tj] = x[
tj] + asydecr * (upp[
tj] - xold1[
tj]);
31 low[
tj] = x[
tj] - asyincr * (xold1[
tj] - low[
tj]);
32 upp[
tj] = x[
tj] + asyincr * (upp[
tj] - xold1[
tj]);
35 low[
tj] = x[
tj] - (xold1[
tj] - low[
tj]);
36 upp[
tj] = x[
tj] + (upp[
tj] - xold1[
tj]);
64 for (
int i = 0; i < m; i++) {
66 (1.001 *
max(
dfdx[i +
tj*m], 0.0) + 0.001 *
69 (0.001 *
max(
dfdx[i +
tj*m], 0.0) + 1.001 *
82 for (
int i = 0; i < m; i++) {
83 temp[i +
tj*m] = pij[i +
tj*m] / (upp[
tj] - x[
tj]) +
84 qij[i +
tj*m] / (x[
tj] - low[
tj]);
95 xsi[
tj] =
max(1.0, 1.0 / (x[
tj] - alpha[
tj]));
108 for (
int i = 0; i < m; i++) {
119 const T e,
const int n) {
138template<
typename T >
149 for (
int i =
idx; i < n; i +=
str) {
173 for (
int i =
idx; i < n; i +=
str)
205 for (
int i = 0; i < m; i++) {
236 const T* eta,
const T* lambda,
const int n,
const int m) {
241 for (
int i = 0; i < m; i++) {
242 sum =
sum + pij[
tj *m+ i] * lambda[i];
248 eta[
tj] / (beta[
tj] - x[
tj]);
269 for (
int i =
idx; i < n; i +=
str)
292template<
typename T >
294 const int n,
const int m,
const int k) {
304 for (
int i =
idx; i < n; i +=
str)
306 sum += a[m * i + k ];
322template<
typename T >
335 for (
int i =
idx; i < n; i +=
str)
354template<
typename T >
357 const int m,
const int k0,
const int k1) {
367 for (
int i =
idx; i < n; i +=
str)
389 const int n,
const int m) {
402 for (
int i0 = 0;
i0 < m;
i0++) {
403 for (
int i1 = 0;
i1 < m;
i1++) {
419 for(
int i=0;i<m;i++){
461 for (
int i = 0; i < m; i++) {
481template<
typename T >
493 for (
int i =
idx; i < n; i +=
str)
517 const T d,
const int n) {
537template<
typename T >
549 for (
int i =
idx; i < n; i +=
str)
569template<
typename T >
581 for (
int i =
idx; i < n; i +=
str)
609 for (
int i = 0; i < m; i++) {
628 template<
typename T >
638 for (
int i =
idx; i<n ; i +=
str)
656 template<
typename T >
670 for (
int i =
idx; i < n; i+=
str) {
694 const T c,
const int n) {
729 const T zeta,
const T z,
const int m) {
734 1.0/ (d[
tj] + mu[
tj] / y[
tj]));
__global__ void convex_down_RAMP_mapping_apply_kernel(const T f_min, const T f_max, const T q, T *__restrict__ X_out_d, T *__restrict__ X_in_d, const int n)
__global__ void mmasumAA_kernel(const T *__restrict__ GG, const T *__restrict__ diagx, T *__restrict__ buf_h, const int n, const int m, const int k0, const int k1)
__inline__ __device__ T reduce_warp(T val)
__global__ void max2_kernel(T *__restrict__ a, const T b, const T *__restrict__ c, const T d, const int n)
__global__ void mmasumbb_kernel(const T *__restrict__ GG, const T *__restrict__ delx, const T *__restrict__ diagx, T *__restrict__ buf_h, const int n, const int m, const int k)
__global__ void add2inv2_kernel(T *__restrict__ a, const T *__restrict__ b, const T c, const int n)
__inline__ __device__ T max_reduce_warp(T val)
__global__ void mmareduce_kernel(T *__restrict__ bufred, const int n)
__global__ void mma_sub4_kernel(const T *__restrict__ x, T *__restrict__ low, T *__restrict__ upp, T *__restrict__ pij, T *__restrict__ qij, T *__restrict__ temp, const int n, const int m)
__global__ void RexCalculation_kernel(T *__restrict__ rex, const T *__restrict__ x, const T *__restrict__ xlow, const T *__restrict__ xupp, const T *__restrict__ pij, const T *__restrict__ p0j, const T *__restrict__ qij, const T *__restrict__ q0j, const T *__restrict__ lambda, const T *__restrict__ xsi, const T *__restrict__ eta, const int n, const int m)
__global__ void relambda_kernel(T *__restrict__ temp, const T *__restrict__ x, const T *__restrict__ xupp, const T *__restrict__ xlow, const T *__restrict__ pij, const T *__restrict__ qij, const int n, const int m)
__global__ void maxval_kernel(const T *__restrict__ a, T *temp, const int n)
__global__ void norm_kernel(const T *__restrict__ a, T *__restrict__ buf_h, const int n)
__global__ void mma_sub2_kernel(T *__restrict__ low, T *__restrict__ upp, const T *__restrict__ x, const T *__restrict__ xold1, const T *__restrict__ xold2, const T *__restrict__ xmin, const T *__restrict__ xmax, const T asydecr, const T asyincr, const int n)
__global__ void dely_kernel(T *__restrict__ dely, const T *__restrict__ c, const T *__restrict__ d, const T *__restrict__ y, const T *__restrict__ lambda, const T epsi, const int n)
__global__ void maxval3_kernel(const T *__restrict__ a, const T *__restrict__ b, const T *__restrict__ c, T *__restrict__ temp, const T cons, const int n)
__global__ void mma_sub1_kernel(T *__restrict__ xlow, T *__restrict__ xupp, const T *__restrict__ x, const T *__restrict__ xmin, const T *__restrict__ xmax, const T asyinit, const int n)
__global__ void mma_copy_kernel(T *__restrict__ a, const T *__restrict__ b, const int n, const int m)
__global__ void mma_max2_kernel(T *__restrict__ xsi, const T *__restrict__ x, T *__restrict__ alpha, const int n)
__global__ void dx_kernel(T *__restrict__ dx, const T *__restrict__ delx, const T *__restrict__ diagx, const T *__restrict__ GG, const T *__restrict__ dlambda, const int n, const int m)
__global__ void kkt_rex_kernel(T *__restrict__ rex, const T *__restrict__ df0dx, const T *__restrict__ dfdx, const T *__restrict__ xsi, const T *__restrict__ eta, const T *__restrict__ lambda, const int n, const int m)
__global__ void maxval2_kernel(const T *__restrict__ a, const T *__restrict__ b, T *__restrict__ temp, const T cons, const int n)
__global__ void deta_kernel(T *__restrict__ deta, const T *__restrict__ eta, const T *__restrict__ dx, const T *__restrict__ x, const T *__restrict__ beta, const T epsi, const int n)
__global__ void updateAA_kernel(T *__restrict__ AA, const T *__restrict__ globaltmp_mm, const T *__restrict__ s, const T *__restrict__ lambda, const T *__restrict__ d, const T *__restrict__ mu, const T *__restrict__ y, const T *__restrict__ a, const T zeta, const T z, const int m)
__global__ void glsc2_kernel(const T *a, const T *b, T *buf_h, const int n)
__global__ void maxcons_kernel(T *__restrict__ a, const T b, const T c, const T *__restrict__ d, const int n)
__global__ void updatebb_kernel(T *__restrict__ bb, const T *__restrict__ dellambda, const T *__restrict__ dely, const T *__restrict__ d, const T *__restrict__ mu, const T *__restrict__ y, const T delz, const int m)
__global__ void glsum_kernel(const T *a, T *buf_h, const int n)
__global__ void mmasum_kernel(const T *__restrict__ a, T *__restrict__ buf_h, const int n, const int m, const int k)
__global__ void diagx_kernel(T *__restrict__ diagx, const T *__restrict__ x, const T *__restrict__ xsi, const T *__restrict__ xlow, const T *__restrict__ xupp, const T *__restrict__ p0j, const T *__restrict__ q0j, const T *__restrict__ pij, const T *__restrict__ qij, const T *alpha, const T *beta, const T *eta, const T *lambda, const int n, const int m)
__global__ void sub2cons_kernel(T *__restrict__ a, const T *__restrict__ b, const T *__restrict__ c, const T d, const int n)
__global__ void sub2cons2_kernel(T *__restrict__ a, const T *__restrict__ b, const T *__restrict__ c, const T *__restrict__ d, const T e, const int n)
__global__ void max_reduce_kernel(T *__restrict__ bufred, const int n)
__global__ void dxsi_kernel(T *__restrict__ dxsi, const T *__restrict__ xsi, const T *__restrict__ dx, const T *__restrict__ x, const T *__restrict__ alpha, const T epsi, const int n)
__global__ void delx_kernel(T *__restrict__ delx, const T *__restrict__ x, const T *__restrict__ xlow, const T *__restrict__ xupp, const T *__restrict__ pij, const T *__restrict__ qij, const T *__restrict__ p0j, const T *__restrict__ q0j, const T *__restrict__ alpha, const T *__restrict__ beta, const T *__restrict__ lambda, const T epsi, const int n, const int m)
__global__ void AA_kernel(T *__restrict__ temp, const T *__restrict__ GG, const T *__restrict__ diagx, const int n, const int m)
__global__ void mma_sub3_kernel(const T *__restrict__ x, const T *__restrict__ df0dx, const T *__restrict__ dfdx, T *__restrict__ low, T *__restrict__ upp, const T *__restrict__ xmin, const T *__restrict__ xmax, T *__restrict__ alpha, T *__restrict__ beta, T *__restrict__ p0j, T *__restrict__ q0j, T *__restrict__ pij, T *__restrict__ qij, const int n, const int m)
__global__ void rey_calculation_kernel(T *__restrict__ rey, const T *__restrict__ c, const T *__restrict__ d, const T *__restrict__ y, const T *__restrict__ lambda, const T *__restrict__ mu, const int n)
__global__ void dy_kernel(T *__restrict__ dy, const T *__restrict__ dely, const T *__restrict__ dlambda, const T *__restrict__ d, const T *__restrict__ mu, const T *__restrict__ y, const int n)
__global__ void GG_kernel(T *__restrict__ GG, const T *__restrict__ x, const T *__restrict__ xlow, const T *__restrict__ xupp, const T *__restrict__ pij, const T *__restrict__ qij, const int n, const int m)