Click here to Skip to main content
15,892,575 members
Articles / High Performance Computing / Vectorization

A C++ String Class

Rate me:
Please Sign up or sign in to vote.
4.96/5 (29 votes)
3 Jan 2015CPOL13 min read 121.2K   2.6K   93  
A fast, reference counted, copy-on-write string class
#include "stdafx.h"

/*
 * -- SuperLU routine (version 3.0) --
 * Univ. of California Berkeley, Xerox Palo Alto Research Center,
 * and Lawrence Berkeley National Lab.
 * October 15, 2003
 *
 */
/*
 * File name:		csp_blas2.c
 * Purpose:		Sparse BLAS 2, using some dense BLAS 2 operations.
 */

#include "hnum_pcsp_defs.h"


namespace harlinn
{
    namespace numerics
    {
        namespace SuperLU
        {
            namespace Complex
            {

                int
                sp_ctrsv(char *uplo, char *trans, char *diag, SuperMatrix *L, 
                         SuperMatrix *U, complex *x, int *info)
                {
                /*
                 *   Purpose
                 *   =======
                 *
                 *   sp_ctrsv() solves one of the systems of equations   
                 *       A*x = b,   or   A'*x = b,
                 *   where b and x are n element vectors and A is a sparse unit , or   
                 *   non-unit, upper or lower triangular matrix.   
                 *   No test for singularity or near-singularity is included in this   
                 *   routine. Such tests must be performed before calling this routine.   
                 *
                 *   Parameters   
                 *   ==========   
                 *
                 *   uplo   - (input) char*
                 *            On entry, uplo specifies whether the matrix is an upper or   
                 *             lower triangular matrix as follows:   
                 *                uplo = 'U' or 'u'   A is an upper triangular matrix.   
                 *                uplo = 'L' or 'l'   A is a lower triangular matrix.   
                 *
                 *   trans  - (input) char*
                 *             On entry, trans specifies the equations to be solved as   
                 *             follows:   
                 *                trans = 'N' or 'n'   A*x = b.   
                 *                trans = 'T' or 't'   A'*x = b.
                 *                trans = 'C' or 'c'   A^H*x = b.   
                 *
                 *   diag   - (input) char*
                 *             On entry, diag specifies whether or not A is unit   
                 *             triangular as follows:   
                 *                diag = 'U' or 'u'   A is assumed to be unit triangular.   
                 *                diag = 'N' or 'n'   A is not assumed to be unit   
                 *                                    triangular.   
                 *	     
                 *   L       - (input) SuperMatrix*
                 *	       The factor L from the factorization Pr*A*Pc=L*U. Use
                 *             compressed row subscripts storage for supernodes,
                 *             i.e., L has types: Stype = SC, Dtype = _C, Mtype = TRLU.
                 *
                 *   U       - (input) SuperMatrix*
                 *	        The factor U from the factorization Pr*A*Pc=L*U.
                 *	        U has types: Stype = NCP, Dtype = _C, Mtype = TRU.
                 *    
                 *   x       - (input/output) complex*
                 *             Before entry, the incremented array X must contain the n   
                 *             element right-hand side vector b. On exit, X is overwritten 
                 *             with the solution vector x.
                 *
                 *   info    - (output) int*
                 *             If *info = -i, the i-th argument had an illegal value.
                 *
                 */
                #if ( MACH==CRAY_PVP )
                    _fcd ftcs1, ftcs2, ftcs3;
                #endif
                    SCPformat *Lstore;
                    NCPformat *Ustore;
                    complex   *Lval, *Uval;
                    int incx = 1, incy = 1;
                    complex temp;
                    complex alpha = {1.0, 0.0}, beta = {1.0, 0.0};
                    complex comp_zero = {0.0, 0.0};
                    register int fsupc, luptr, istart, irow, k, iptr, jcol, nsuper;
                    int          nsupr, nsupc, nrow, i;
                    complex *work;
                    flops_t solve_ops;

                    /* Test the input parameters */
                    *info = 0;
                    if ( !lsame_(uplo,"L") && !lsame_(uplo, "U") ) *info = -1;
                    else if ( !lsame_(trans, "N") && !lsame_(trans, "T") ) *info = -2;
                    else if ( !lsame_(diag, "U") && !lsame_(diag, "N") ) *info = -3;
                    else if ( L->nrow != L->ncol || L->nrow < 0 ) *info = -4;
                    else if ( U->nrow != U->ncol || U->nrow < 0 ) *info = -5;
                    if ( *info ) {
	                i = -(*info);
	                xerbla_("sp_ctrsv", &i);
	                return 0;
                    }

                    Lstore = (SCPformat*) L->Store;
                    Lval = (complex*) Lstore->nzval;
                    Ustore = (NCPformat*) U->Store;
                    Uval = (complex*) Ustore->nzval;
                    nsuper = Lstore->nsuper;
                    solve_ops = 0;

                    if ( !(work = complexCalloc(L->nrow)) )
	                SUPERLU_ABORT("Malloc fails for work in sp_ctrsv().");
    
                    if ( lsame_(trans, "N") ) {	/* Form x := inv(A)*x. */
	
	                if ( lsame_(uplo, "L") ) {
	                    /* Form x := inv(L)*x */
    	                    if ( L->nrow == 0 ) return 0; /* Quick return */
	    
	                    for (k = 0; k <= nsuper; k++) {
		                fsupc = L_FST_SUPC(k);
		                istart = L_SUB_START(fsupc);
                                nsupr = L_SUB_END(fsupc) - istart;
                                nsupc = L_LAST_SUPC(k) - fsupc;
		                luptr = L_NZ_START(fsupc);
		                nrow = nsupr - nsupc;

                                /* 1 c_div costs 10 flops */
	                        solve_ops += 4 * nsupc * (nsupc - 1) + 10 * nsupc;
	                        solve_ops += 8 * nrow * nsupc;

		                if ( nsupc == 1 ) {
		                    for (iptr=istart+1; iptr < L_SUB_END(fsupc); ++iptr) {
			                irow = L_SUB(iptr);
			                ++luptr;
			                cc_mult(&comp_zero, &x[fsupc], &Lval[luptr]);
			                c_sub(&x[irow], &x[irow], &comp_zero);
		                    }
		                } else {
                #ifdef USE_VENDOR_BLAS
                #if ( MACH==CRAY_PVP )
                                    ftcs1 = _cptofcd("L", strlen("L"));
                                    ftcs2 = _cptofcd("N", strlen("N"));
                                    ftcs3 = _cptofcd("U", strlen("U"));

		                    CTRSV(ftcs1, ftcs2, ftcs3, &nsupc, &Lval[luptr], &nsupr,
		       	                &x[fsupc], &incx);
		
		                    CGEMV(ftcs2, &nrow, &nsupc, &alpha, &Lval[luptr+nsupc], 
		       	                &nsupr, &x[fsupc], &incx, &beta, &work[0], &incy);
                #else
		                    ctrsv_("L", "N", "U", &nsupc, &Lval[luptr], &nsupr,
		       	                &x[fsupc], &incx);
		
		                    cgemv_("N", &nrow, &nsupc, &alpha, &Lval[luptr+nsupc], 
		       	                &nsupr, &x[fsupc], &incx, &beta, &work[0], &incy);
                #endif
                #else
		                    clsolve (nsupr, nsupc, &Lval[luptr], &x[fsupc]);
		
		                    cmatvec (nsupr, nsupr-nsupc, nsupc, &Lval[luptr+nsupc],
                                             &x[fsupc], &work[0] );
                #endif		
		
		                    iptr = istart + nsupc;
		                    for (i = 0; i < nrow; ++i, ++iptr) {
			                irow = L_SUB(iptr);
			                c_sub(&x[irow], &x[irow], &work[i]); /* Scatter */
			                work[i] = comp_zero;

		                    }
	 	                }
	                    } /* for k ... */
	    
	                } else {
	                    /* Form x := inv(U)*x */
	    
	                    if ( U->nrow == 0 ) return 0; /* Quick return */
	    
	                    for (k = nsuper; k >= 0; k--) {
	    	                fsupc = L_FST_SUPC(k);
                                nsupr = L_SUB_END(fsupc) - L_SUB_START(fsupc);
                                nsupc = L_LAST_SUPC(k) - fsupc;
	    	                luptr = L_NZ_START(fsupc);
		
                                /* 1 c_div costs 10 flops */
    	                        solve_ops += 4 * nsupc * (nsupc + 1) + 10 * nsupc;

		                if ( nsupc == 1 ) {
		                    c_div(&x[fsupc], &x[fsupc], &Lval[luptr]);
		                    for (i = U_NZ_START(fsupc); i < U_NZ_END(fsupc); ++i) {
			                irow = U_SUB(i);
			                cc_mult(&comp_zero, &x[fsupc], &Uval[i]);
			                c_sub(&x[irow], &x[irow], &comp_zero);
		                    }
		                } else {
                #ifdef USE_VENDOR_BLAS
                #if ( MACH==CRAY_PVP )
                                    ftcs1 = _cptofcd("U", strlen("U"));
                                    ftcs2 = _cptofcd("N", strlen("N"));
                                    ftcs3 = _cptofcd("N", strlen("N"));

		                    CTRSV(ftcs1, ftcs2, ftcs3, &nsupc, &Lval[luptr], &nsupr,
		                       &x[fsupc], &incx);
                #else
		                    ctrsv_("U", "N", "N", &nsupc, &Lval[luptr], &nsupr,
                                           &x[fsupc], &incx);
                #endif
                #else		
		                    cusolve ( nsupr, nsupc, &Lval[luptr], &x[fsupc] );
                #endif		

                                    for (jcol = fsupc; jcol < fsupc + nsupc; jcol++) {
		                        solve_ops += 8*(U_NZ_END(jcol) - U_NZ_START(jcol));
		    	                for (i = U_NZ_START(jcol); i < U_NZ_END(jcol); i++) {
			                    irow = U_SUB(i);
			                cc_mult(&comp_zero, &x[jcol], &Uval[i]);
			                c_sub(&x[irow], &x[irow], &comp_zero);
		    	                }
                                    }
		                }
	                    } /* for k ... */
	    
	                }
                    } else if ( lsame_(trans, "T") ) { /* Form x := inv(A')*x */
	
	                if ( lsame_(uplo, "L") ) {
	                    /* Form x := inv(L')*x */
    	                    if ( L->nrow == 0 ) return 0; /* Quick return */
	    
	                    for (k = Lstore->nsuper; k >= 0; --k) {
	    	                fsupc = L_FST_SUPC(k);
	    	                istart = L_SUB_START(fsupc);
                                nsupr = L_SUB_END(fsupc) - istart;
                                nsupc = L_LAST_SUPC(k) - fsupc;
	    	                luptr = L_NZ_START(fsupc);

		                solve_ops += 8 * (nsupr - nsupc) * nsupc;

		                for (jcol = fsupc; jcol < L_LAST_SUPC(k); jcol++) {
		                    iptr = istart + nsupc;
		                    for (i = L_NZ_START(jcol) + nsupc; 
				                i < L_NZ_END(jcol); i++) {
			                irow = L_SUB(iptr);
			                cc_mult(&comp_zero, &x[irow], &Lval[i]);
		    	                c_sub(&x[jcol], &x[jcol], &comp_zero);
			                iptr++;
		                    }
		                }
		
		                if ( nsupc > 1 ) {
		                    solve_ops += 4 * nsupc * (nsupc - 1);
                #ifdef _CRAY
                                    ftcs1 = _cptofcd("L", strlen("L"));
                                    ftcs2 = _cptofcd("T", strlen("T"));
                                    ftcs3 = _cptofcd("U", strlen("U"));
		                    CTRSV(ftcs1, ftcs2, ftcs3, &nsupc, &Lval[luptr], &nsupr,
			                &x[fsupc], &incx);
                #else
		                    ctrsv_("L", "T", "U", &nsupc, &Lval[luptr], &nsupr,
			                &x[fsupc], &incx);
                #endif
		                }
	                    }
	                } else {
	                    /* Form x := inv(U')*x */
	                    if ( U->nrow == 0 ) return 0; /* Quick return */
	    
	                    for (k = 0; k <= nsuper; k++) {
	    	                fsupc = L_FST_SUPC(k);
                                nsupr = L_SUB_END(fsupc) - L_SUB_START(fsupc);
                                nsupc = L_LAST_SUPC(k) - fsupc;
	    	                luptr = L_NZ_START(fsupc);

                                for (jcol = fsupc; jcol < fsupc + nsupc; jcol++) {
		                    solve_ops += 8*(U_NZ_START(jcol+1) - U_NZ_START(jcol));
                                    for (i = U_NZ_START(jcol); i < U_NZ_END(jcol); i++) {
			                irow = U_SUB(i);
			                cc_mult(&comp_zero, &x[irow], &Uval[i]);
		    	                c_sub(&x[jcol], &x[jcol], &comp_zero);
		                    }
		                }

                                /* 1 c_div costs 10 flops */
		                solve_ops += 4 * nsupc * (nsupc + 1) + 10 * nsupc;

		                if ( nsupc == 1 ) {
		                    c_div(&x[fsupc], &x[fsupc], &Lval[luptr]);
		                } else {
                #ifdef _CRAY
                                    ftcs1 = _cptofcd("U", strlen("U"));
                                    ftcs2 = _cptofcd("T", strlen("T"));
                                    ftcs3 = _cptofcd("N", strlen("N"));
		                    CTRSV( ftcs1, ftcs2, ftcs3, &nsupc, &Lval[luptr], &nsupr,
			                    &x[fsupc], &incx);
                #else
		                    ctrsv_("U", "T", "N", &nsupc, &Lval[luptr], &nsupr,
			                    &x[fsupc], &incx);
                #endif
		                }
	                    } /* for k ... */
	                }
                    } else { /* Form x := conj(inv(A'))*x */
	
	                if ( lsame_(uplo, "L") ) {
	                    /* Form x := conj(inv(L'))*x */
    	                    if ( L->nrow == 0 ) return 0; /* Quick return */
	    
	                    for (k = Lstore->nsuper; k >= 0; --k) {
	    	                fsupc = L_FST_SUPC(k);
	    	                istart = L_SUB_START(fsupc);
	    	                nsupr = L_SUB_END(fsupc) - istart;
	    	                nsupc = L_LAST_SUPC(k) - fsupc;
	    	                luptr = L_NZ_START(fsupc);

		                solve_ops += 8 * (nsupr - nsupc) * nsupc;

		                for (jcol = fsupc; jcol < L_FST_SUPC(k+1); jcol++) {
		                    iptr = istart + nsupc;
		                    for (i = L_NZ_START(jcol) + nsupc; 
				                i < L_NZ_START(jcol+1); i++) {
			                irow = L_SUB(iptr);
                                        cc_conj(&temp, &Lval[i]);
			                cc_mult(&comp_zero, &x[irow], &temp);
		    	                c_sub(&x[jcol], &x[jcol], &comp_zero);
			                iptr++;
		                    }
 		                }
 		
 		                if ( nsupc > 1 ) {
		                    solve_ops += 4 * nsupc * (nsupc - 1);
                #ifdef _CRAY
                                    ftcs1 = _cptofcd("L", strlen("L"));
                                    ftcs2 = _cptofcd(trans, strlen("T"));
                                    ftcs3 = _cptofcd("U", strlen("U"));
		                    CTRSV(ftcs1, ftcs2, ftcs3, &nsupc, &Lval[luptr], &nsupr,
			                &x[fsupc], &incx);
                #else
                                    ctrsv_("L", trans, "U", &nsupc, &Lval[luptr], &nsupr,
                                           &x[fsupc], &incx);
                #endif
		                }
	                    }
	                } else {
	                    /* Form x := conj(inv(U'))*x */
	                    if ( U->nrow == 0 ) return 0; /* Quick return */
	    
	                    for (k = 0; k <= Lstore->nsuper; k++) {
	    	                fsupc = L_FST_SUPC(k);
	    	                nsupr = L_SUB_START(fsupc+1) - L_SUB_START(fsupc);
	    	                nsupc = L_FST_SUPC(k+1) - fsupc;
	    	                luptr = L_NZ_START(fsupc);

		                for (jcol = fsupc; jcol < L_FST_SUPC(k+1); jcol++) {
		                    solve_ops += 8*(U_NZ_START(jcol+1) - U_NZ_START(jcol));
		                    for (i = U_NZ_START(jcol); i < U_NZ_START(jcol+1); i++) {
			                irow = U_SUB(i);
                                        cc_conj(&temp, &Uval[i]);
			                cc_mult(&comp_zero, &x[irow], &temp);
		    	                c_sub(&x[jcol], &x[jcol], &comp_zero);
		                    }
		                }

                                /* 1 c_div costs 10 flops */
		                solve_ops += 4 * nsupc * (nsupc + 1) + 10 * nsupc;
 
		                if ( nsupc == 1 ) {
                                    cc_conj(&temp, &Lval[luptr]);
		                    c_div(&x[fsupc], &x[fsupc], &temp);
		                } else {
                #ifdef _CRAY
                                    ftcs1 = _cptofcd("U", strlen("U"));
                                    ftcs2 = _cptofcd(trans, strlen("T"));
                                    ftcs3 = _cptofcd("N", strlen("N"));
		                    CTRSV( ftcs1, ftcs2, ftcs3, &nsupc, &Lval[luptr], &nsupr,
			                    &x[fsupc], &incx);
                #else
                                    ctrsv_("U", trans, "N", &nsupc, &Lval[luptr], &nsupr,
                                               &x[fsupc], &incx);
                #endif
  		                }
  	                    } /* for k ... */
  	                }
                    }

                    SUPERLU_FREE(work);
                    return 0;
                }



                int
                sp_cgemv(char *trans, complex alpha, SuperMatrix *A, complex *x, 
	                 int incx, complex beta, complex *y, int incy)
                {
                /*  Purpose   
                    =======   

                    sp_cgemv()  performs one of the matrix-vector operations   
                       y := alpha*A*x + beta*y,   or   y := alpha*A'*x + beta*y,   
                    where alpha and beta are scalars, x and y are vectors and A is a
                    sparse A->nrow by A->ncol matrix.   

                    Parameters   
                    ==========   

                    TRANS  - (input) char*
                             On entry, TRANS specifies the operation to be performed as   
                             follows:   
                                TRANS = 'N' or 'n'   y := alpha*A*x + beta*y.   
                                TRANS = 'T' or 't'   y := alpha*A'*x + beta*y.   
                                TRANS = 'C' or 'c'   y := alpha*A'*x + beta*y.   

                    ALPHA  - (input) complex
                             On entry, ALPHA specifies the scalar alpha.   

                    A      - (input) SuperMatrix*
                             Before entry, the leading m by n part of the array A must   
                             contain the matrix of coefficients.   

                    X      - (input) complex*, array of DIMENSION at least   
                             ( 1 + ( n - 1 )*abs( INCX ) ) when TRANS = 'N' or 'n'   
                             and at least   
                             ( 1 + ( m - 1 )*abs( INCX ) ) otherwise.   
                             Before entry, the incremented array X must contain the   
                             vector x.   

                    INCX   - (input) int
                             On entry, INCX specifies the increment for the elements of   
                             X. INCX must not be zero.   

                    BETA   - (input) complex
                             On entry, BETA specifies the scalar beta. When BETA is   
                             supplied as zero then Y need not be set on input.   

                    Y      - (output) complex*,  array of DIMENSION at least   
                             ( 1 + ( m - 1 )*abs( INCY ) ) when TRANS = 'N' or 'n'   
                             and at least   
                             ( 1 + ( n - 1 )*abs( INCY ) ) otherwise.   
                             Before entry with BETA non-zero, the incremented array Y   
                             must contain the vector y. On exit, Y is overwritten by the 
                             updated vector y.
	     
                    INCY   - (input) int
                             On entry, INCY specifies the increment for the elements of   
                             Y. INCY must not be zero.   

                    ==== Sparse Level 2 Blas routine.   
                */

                    /* Local variables */
                    NCformat *Astore;
                    complex   *Aval;
                    int info;
                    complex temp, temp1;
                    int lenx, leny, i, j, irow;
                    int iy, jx, jy, kx, ky;
                    int notran;
                    complex comp_zero = {0.0, 0.0};
                    complex comp_one = {1.0, 0.0};

                    notran = lsame_(trans, "N");
                    Astore = (NCformat *)A->Store;
                    Aval = (complex *)Astore->nzval;
    
                    /* Test the input parameters */
                    info = 0;
                    if ( !notran && !lsame_(trans, "T") && !lsame_(trans, "C")) info = 1;
                    else if ( A->nrow < 0 || A->ncol < 0 ) info = 3;
                    else if (incx == 0) info = 5;
                    else if (incy == 0)	info = 8;
                    if (info != 0) {
	                xerbla_("sp_cgemv ", &info);
	                return 0;
                    }

                    /* Quick return if possible. */
                    if (A->nrow == 0 || A->ncol == 0 || 
	                c_eq(&alpha, &comp_zero) && 
	                c_eq(&beta, &comp_one))
	                return 0;


                    /* Set  LENX  and  LENY, the lengths of the vectors x and y, and set 
                       up the start points in  X  and  Y. */
                    if (lsame_(trans, "N")) {
	                lenx = A->ncol;
	                leny = A->nrow;
                    } else {
	                lenx = A->nrow;
	                leny = A->ncol;
                    }
                    if (incx > 0) kx = 0;
                    else kx =  - (lenx - 1) * incx;
                    if (incy > 0) ky = 0;
                    else ky =  - (leny - 1) * incy;

                    /* Start the operations. In this version the elements of A are   
                       accessed sequentially with one pass through A. */
                    /* First form  y := beta*y. */
                    if ( !c_eq(&beta, &comp_one) ) {
	                if (incy == 1) {
	                    if ( c_eq(&beta, &comp_zero) )
		                for (i = 0; i < leny; ++i) y[i] = comp_zero;
	                    else
		                for (i = 0; i < leny; ++i) 
		                  cc_mult(&y[i], &beta, &y[i]);
	                } else {
	                    iy = ky;
	                    if ( c_eq(&beta, &comp_zero) )
		                for (i = 0; i < leny; ++i) {
		                    y[iy] = comp_zero;
		                    iy += incy;
		                }
	                    else
		                for (i = 0; i < leny; ++i) {
		                    cc_mult(&y[iy], &beta, &y[iy]);
		                    iy += incy;
		                }
	                }
                    }
    
                    if ( c_eq(&alpha, &comp_zero) ) return 0;

                    if ( notran ) {
	                /* Form  y := alpha*A*x + y. */
	                jx = kx;
	                if (incy == 1) {
	                    for (j = 0; j < A->ncol; ++j) {
		                if ( !c_eq(&x[jx], &comp_zero) ) {
		                    cc_mult(&temp, &alpha, &x[jx]);
		                    for (i = Astore->colptr[j]; i < Astore->colptr[j+1]; ++i) {
			                irow = Astore->rowind[i];
			                cc_mult(&temp1, &temp,  &Aval[i]);
			                c_add(&y[irow], &y[irow], &temp1);
		                    }
		                }
		                jx += incx;
	                    }
	                } else {
	                    SUPERLU_ABORT("Not implemented.");
	                }
                    } else {
	                /* Form  y := alpha*A'*x + y. */
	                jy = ky;
	                if (incx == 1) {
	                    for (j = 0; j < A->ncol; ++j) {
		                temp = comp_zero;
		                for (i = Astore->colptr[j]; i < Astore->colptr[j+1]; ++i) {
		                    irow = Astore->rowind[i];
		                    cc_mult(&temp1, &Aval[i], &x[irow]);
		                    c_add(&temp, &temp, &temp1);
		                }
		                cc_mult(&temp1, &alpha, &temp);
		                c_add(&y[jy], &y[jy], &temp1);
		                jy += incy;
	                    }
	                } else {
	                    SUPERLU_ABORT("Not implemented.");
	                }
                    }
                    return 0;    
                } /* sp_cgemv */

            };
        };
    };
};

By viewing downloads associated with this article you agree to the Terms of Service and the article's licence.

If a file you wish to view isn't highlighted, and is a text file (not binary), please let us know and we'll add colourisation support for it.

License

This article, along with any associated source code and files, is licensed under The Code Project Open License (CPOL)


Written By
Architect Sea Surveillance AS
Norway Norway
Chief Architect - Sea Surveillance AS.

Specializing in integrated operations and high performance computing solutions.

I’ve been fooling around with computers since the early eighties, I’ve even done work on CP/M and MP/M.

Wrote my first “real” program on a BBC micro model B based on a series in a magazine at that time. It was fun and I got hooked on this thing called programming ...

A few Highlights:

  • High performance application server development
  • Model Driven Architecture and Code generators
  • Real-Time Distributed Solutions
  • C, C++, C#, Java, TSQL, PL/SQL, Delphi, ActionScript, Perl, Rexx
  • Microsoft SQL Server, Oracle RDBMS, IBM DB2, PostGreSQL
  • AMQP, Apache qpid, RabbitMQ, Microsoft Message Queuing, IBM WebSphereMQ, Oracle TuxidoMQ
  • Oracle WebLogic, IBM WebSphere
  • Corba, COM, DCE, WCF
  • AspenTech InfoPlus.21(IP21), OsiSoft PI


More information about what I do for a living can be found at: harlinn.com or LinkedIn

You can contact me at espen@harlinn.no

Comments and Discussions